diff --git a/DESCRIPTION b/DESCRIPTION index a1a190f4..5b771d83 100644 --- a/DESCRIPTION +++ b/DESCRIPTION @@ -57,10 +57,11 @@ Suggests: kableExtra, colorspace, magrittr, - vdiffr + vdiffr, + httptest License: MIT + file LICENSE LazyData: true -RoxygenNote: 7.2.3 +RoxygenNote: 7.3.1 VignetteBuilder: knitr Encoding: UTF-8 Config/testthat/edition: 3 diff --git a/NAMESPACE b/NAMESPACE index 4ca7696c..bf35c773 100644 --- a/NAMESPACE +++ b/NAMESPACE @@ -157,6 +157,7 @@ importFrom(tcplfit2,tcplhit2_core) importFrom(tidyr,pivot_longer) importFrom(tidyr,pivot_wider) importFrom(tidyr,separate_wider_delim) +importFrom(tidyr,unnest) importFrom(tidyr,unnest_longer) importFrom(utils,data) importFrom(utils,read.csv) diff --git a/R/sc1_mthds.R b/R/sc1_mthds.R index 613d6dce..aebf76a2 100644 --- a/R/sc1_mthds.R +++ b/R/sc1_mthds.R @@ -45,6 +45,8 @@ #' \item{bval.apid.tn.med}{Calculate the baseline value (bval) as the plate-wise median, #' by assay plate ID (apid), of the raw values (rval) for test compound wells (wllt = t) #' and neutral control wells (wllt = n).} +#' \item{bval.nwlls.med}{Calculate the baseline value (bval) as the median of the raw values +#' (rval) for neutral control wells (wllt = n) by assay endpoint id (aeid).} #' } #' } #' @@ -131,6 +133,14 @@ sc1_mthds <- function() { by = list(aeid, apid)]) list(e1) + }, + bval.nwlls.med = function(aeids) { + + e1 <- bquote(dat[J(.(aeids)), + bval := median(rval[wllt == "n"], na.rm = TRUE), + by = list(aeid)]) + list(e1) + }, pval.apid.pwlls.med = function(aeids) { diff --git a/R/tcplConfDefault.R b/R/tcplConfDefault.R index a2254b22..4f3f94f5 100644 --- a/R/tcplConfDefault.R +++ b/R/tcplConfDefault.R @@ -7,8 +7,8 @@ tcplConfDefault <- function () { - TCPLlite <- file.path(system.file(package = "tcpl"), "csv") - tcplConf(db = TCPLlite, user = NA, host = NA, drvr = "tcplLite") + tcpl_key <- "01cbaf22-904f-11ee-954e-325096b39f47" + tcplConf(db = NA, user = NA, pass = tcpl_key, host = NULL, drvr = "API") } diff --git a/R/tcplPlot.R b/R/tcplPlot.R index 4d9d31ec..7942f9ad 100644 --- a/R/tcplPlot.R +++ b/R/tcplPlot.R @@ -68,7 +68,7 @@ tcplPlot <- function(dat = NULL, type = "mc", fld = "m4id", val = NULL, compare. list2env(validated_vars, envir = environment()) # check_tcpl_db_schema is a user-defined function found in v3_schema_functions.R file - if (check_tcpl_db_schema() | !is.null(dat)) { + if (check_tcpl_db_schema() | !is.null(dat) | getOption("TCPL_DRVR") == "API") { # check if user supplied data. If not, load from db connection if(is.null(dat)){ dat <- tcplPlotLoadData(lvl = lvl, fld = fld, val = val, type = type,flags = flags, compare = FALSE) #code defined in tcplPlotUtils.R @@ -114,7 +114,7 @@ tcplPlot <- function(dat = NULL, type = "mc", fld = "m4id", val = NULL, compare. nrow = ncol = 1 } # error message for output="console" and multi=FALSE to avoid multiple plots in console - if(nrow(dat) > 1 && output == "console" && multi == FALSE) stop("More than 1 concentration series returned for given field/val combination. Set output to pdf or reduce the number of curves to 1. Current number of curves: ", nrow(input)) + if(nrow(dat[compare == FALSE]) != 1 && output == "console" && multi == FALSE) stop("More than 1 concentration series returned for given field/val combination. Set output to pdf or reduce the number of curves to 1. Current number of curves: ", nrow(dat)) if(is.null(nrow)){ nrow <- ifelse(verbose,2,2) } @@ -132,7 +132,7 @@ tcplPlot <- function(dat = NULL, type = "mc", fld = "m4id", val = NULL, compare. # tcplPlotlyplot is the user-defined function found in tcplPlot.R file used to connect tcpl and plotly packages # tcplggplot is the user-defined function found in tcplPlot.R file used to connect tcpl and ggplot2 packages return(tcplPlotlyPlot(dat, lvl)), - return(ggsave(filename=paste0(fileprefix,"_",paste0(dat$m4id, collapse = "_"),".",output), + return(ggsave(filename=paste0(fileprefix,"_",paste0(ifelse(type=="mc",dat$m4id,dat$s2id), collapse = "_"),".",output), plot= if(is.null(compare.val)) tcplggplot(dat,verbose = verbose, lvl = lvl, flags = flags, yrange = yrange) else tcplggplotCompare(dat[compare == FALSE],dat[compare == TRUE],verbose = verbose, lvl = lvl, flags = flags, yrange = yrange), width = 7, height = 5, dpi=dpi)) ) } else { @@ -399,6 +399,22 @@ tcplPlotlyPlot <- function(dat, lvl = 5){ } } + } else if (lvl == 2) { #single conc + # main data + if (!is.null(dat$coff) && dat$max_med < 0) { + dat$coff <- dat$coff * -1 + } + if (!is.null(dat$coff) && !is.null(dat$hitc) && dat$hitc < 0) { + dat$coff <- dat$coff * -1 + } + + # compare data + if (!is.null(compare.dat$coff) && compare.dat$max_med < 0) { + compare.dat$coff <- compare.dat$coff * -1 + } + if (!is.null(compare.dat$coff) && !is.null(compare.dat$hitc) && compare.dat$hitc < 0) { + compare.dat$coff <- compare.dat$coff * -1 + } } # function for truncating decimals @@ -500,7 +516,7 @@ tcplPlotlyPlot <- function(dat, lvl = 5){ inherit = FALSE, hoverinfo = "text", text = ~ paste( - "
", paste0("Cut Off B (", specify_decimal(dat$coff,2), ")") + "
", paste0("Cut Off B (", specify_decimal(compare.dat$coff,2), ")") ) ) } @@ -831,37 +847,47 @@ tcplggplot <- function(dat, lvl = 5, verbose = FALSE, flags = FALSE, yrange = c( range() # check if model_type is 3 or 4, which means an override method was assigned - if (lvl == 5 && dat$model_type == 3) { # gain direction - # leave coff but bmr should flip if top is negative - if (!is.null(dat$top) && !is.na(dat$top) && !is.null(dat$bmr)) { - if (dat$top < 0) { - dat$bmr <- dat$bmr * -1 + if (lvl == 5) { + if (dat$model_type == 3) { # gain direction + # leave coff but bmr should flip if top is negative + if (!is.null(dat$top) && !is.na(dat$top) && !is.null(dat$bmr)) { + if (dat$top < 0) { + dat$bmr <- dat$bmr * -1 + } + } + } else if (dat$model_type == 4) { # loss direction + # coff and bmr(if top < 0) should be negative + if (!is.null(dat$top) && !is.null(dat$coff) && !is.na(dat$top) && !is.null(dat$bmr)) { + dat$coff <- dat$coff * -1 + if (dat$top < 0) { + dat$bmr <- dat$bmr * -1 + } + } + } else { # bidirectional + # check if winning model has negative top. If so coff,bmr should be negative + if (!is.null(dat$top) && !is.null(dat$coff) && !is.na(dat$top) && !is.null(dat$bmr)) { + if (dat$top < 0) { + dat$coff <- dat$coff * -1 + dat$bmr <- dat$bmr * -1 + } } } - } else if (lvl == 5 && dat$model_type == 4) { # loss direction - # coff and bmr(if top < 0) should be negative - if (!is.null(dat$top) && !is.null(dat$coff) && !is.na(dat$top) && !is.null(dat$bmr)) { + } else { #single conc + if (!is.null(dat$coff) && dat$max_med < 0) { dat$coff <- dat$coff * -1 - if (dat$top < 0) { - dat$bmr <- dat$bmr * -1 - } } - } else { # bidirectional - # check if winning model has negative top. If so coff,bmr should be negative - if (!is.null(dat$top) && !is.null(dat$coff) && !is.na(dat$top) && !is.null(dat$bmr)) { - if (dat$top < 0) { - dat$coff <- dat$coff * -1 - dat$bmr <- dat$bmr * -1 - } + if (!is.null(dat$coff) && !is.null(dat$hitc) && dat$hitc < 0) { + dat$coff <- dat$coff * -1 } } + # check if ac50 is null and assign NA if it is dat$ac50 <- ifelse(is.null(dat$ac50), NA, dat$ac50) # check if dtxsid is NA, pull wllt in from lvl 3 - if (is.na(dat$dsstox_substance_id) | is.na(dat$chnm)) { - wllt <- unique(tcplLoadData(lvl = 0, fld = list("spid","acid"), + if (getOption("TCPL_DRVR") != "API" && (is.na(dat$dsstox_substance_id) | is.na(dat$chnm))) { + wllt <- unique(tcplLoadData(type = ifelse(lvl == 2, "sc", "mc"), lvl = 0, fld = list("spid","acid"), list(dat$spid, tcplLoadAcid(fld = "aeid", val = dat$aeid)$acid))$wllt) if (length(wllt) == 1) { if (wllt == 'c' | wllt == 'p') { @@ -885,13 +911,18 @@ tcplggplot <- function(dat, lvl = 5, verbose = FALSE, flags = FALSE, yrange = c( dat$chnm <- "" } else { - data$dsstox_substance_id <- paste0("Well type: ", wllt) - data$chnm <- "" + dat$dsstox_substance_id <- paste0("Well type: ", wllt) + dat$chnm <- "" } } else { - warning(paste0("wllt for SPID: ", dat$spid, " is missing or length > 1. + if (length(wllt) > 1) { + dat$dsstox_substance_id <- paste0("Well type: ", paste(wllt, collapse = ", ")) + dat$chnm <- "" + } else { + warning(paste0("wllt for SPID: ", dat$spid, " is missing. Leaving dsstox_substance_id and chnm as NA.")) + } } } @@ -915,7 +946,7 @@ tcplggplot <- function(dat, lvl = 5, verbose = FALSE, flags = FALSE, yrange = c( if (lvl == 2) { gg <- ggplot(l3_dat, aes(x = conc)) + geom_hline(aes(yintercept = dat$max_med, linetype = "Max Median"), color="red") + - geom_hline(aes(yintercept = ifelse(dat$max_med >= 0, dat$coff, dat$coff * -1), linetype="Cutoff"), color="blue") + + geom_hline(aes(yintercept = dat$coff, linetype="Cutoff"), color="blue") + geom_point(aes(y = resp)) + scale_x_continuous(limits = l3_range, trans = ifelse(0 %in% l3_dat$conc,"identity","log10")) + scale_y_continuous(limits = yrange) + @@ -1093,62 +1124,77 @@ tcplggplotCompare <- function(dat, compare.dat, lvl = 5, verbose = FALSE, flags if (dat$conc_unit != compare.dat$conc_unit || dat$normalized_data_type != compare.dat$normalized_data_type) stop("Units do not match.") - # main data # check if model_type is 3 or 4, which means an override method was assigned - if (lvl == 5 && dat$model_type == 3) { # gain direction - # leave coff but bmr should flip if top is negative - if (!is.null(dat$top) && !is.na(dat$top) && !is.null(dat$bmr)) { - if (dat$top < 0) { - dat$bmr <- dat$bmr * -1 - } - } - } else if (lvl == 5 && dat$model_type == 4) { # loss direction - # coff and bmr(if top < 0) should be negative - if (!is.null(dat$top) && !is.null(dat$coff) && !is.na(dat$top) && !is.null(dat$bmr)) { - dat$coff <- dat$coff * -1 - if (dat$top < 0) { - dat$bmr <- dat$bmr * -1 + if (lvl == 5) { + # main data + if (dat$model_type == 3) { # gain direction + # leave coff but bmr should flip if top is negative + if (!is.null(dat$top) && !is.na(dat$top) && !is.null(dat$bmr)) { + if (dat$top < 0) { + dat$bmr <- dat$bmr * -1 + } } - } - } else { # bidirectional - # check if winning model has negative top. If so coff,bmr should be negative - if (!is.null(dat$top) && !is.null(dat$coff) && !is.na(dat$top) && !is.null(dat$bmr)) { - if (dat$top < 0) { + } else if (dat$model_type == 4) { # loss direction + # coff and bmr(if top < 0) should be negative + if (!is.null(dat$top) && !is.null(dat$coff) && !is.na(dat$top) && !is.null(dat$bmr)) { dat$coff <- dat$coff * -1 - dat$bmr <- dat$bmr * -1 + if (dat$top < 0) { + dat$bmr <- dat$bmr * -1 + } } - } - } - - # compare data - # check if model_type is 3 or 4, which means an override method was assigned - if (lvl == 5 && compare.dat$model_type == 3) { # gain direction - # leave coff but bmr should flip if top is negative - if (!is.null(compare.dat$top) && !is.na(compare.dat$top) && !is.null(compare.dat$bmr)) { - if (compare.dat$top < 0) { - compare.dat$bmr <- compare.dat$bmr * -1 + } else { # bidirectional + # check if winning model has negative top. If so coff,bmr should be negative + if (!is.null(dat$top) && !is.null(dat$coff) && !is.na(dat$top) && !is.null(dat$bmr)) { + if (dat$top < 0) { + dat$coff <- dat$coff * -1 + dat$bmr <- dat$bmr * -1 + } } } - } else if (lvl == 5 && compare.dat$model_type == 4) { # loss direction - # coff and bmr(if top < 0) should be negative - if (!is.null(compare.dat$top) && !is.null(compare.dat$coff) && !is.na(compare.dat$top) && !is.null(compare.dat$bmr)) { - compare.dat$coff <- compare.dat$coff * -1 - if (compare.dat$top < 0) { - compare.dat$bmr <- compare.dat$bmr * -1 + + # compare data + if (compare.dat$model_type == 3) { # gain direction + # leave coff but bmr should flip if top is negative + if (!is.null(compare.dat$top) && !is.na(compare.dat$top) && !is.null(compare.dat$bmr)) { + if (compare.dat$top < 0) { + compare.dat$bmr <- compare.dat$bmr * -1 + } } - } - } else { # bidirectional - # check if winning model has negative top. If so coff,bmr should be negative - if (!is.null(compare.dat$top) && !is.null(compare.dat$coff) && !is.na(compare.dat$top) && !is.null(compare.dat$bmr)) { - if (compare.dat$top < 0) { + } else if (compare.dat$model_type == 4) { # loss direction + # coff and bmr(if top < 0) should be negative + if (!is.null(compare.dat$top) && !is.null(compare.dat$coff) && !is.na(compare.dat$top) && !is.null(compare.dat$bmr)) { compare.dat$coff <- compare.dat$coff * -1 - compare.dat$bmr <- compare.dat$bmr * -1 + if (compare.dat$top < 0) { + compare.dat$bmr <- compare.dat$bmr * -1 + } } + } else { # bidirectional + # check if winning model has negative top. If so coff,bmr should be negative + if (!is.null(compare.dat$top) && !is.null(compare.dat$coff) && !is.na(compare.dat$top) && !is.null(compare.dat$bmr)) { + if (compare.dat$top < 0) { + compare.dat$coff <- compare.dat$coff * -1 + compare.dat$bmr <- compare.dat$bmr * -1 + } + } + } + } else { #single conc + # main data + if (!is.null(dat$coff) && dat$max_med < 0) { + dat$coff <- dat$coff * -1 + } + if (!is.null(dat$coff) && !is.null(dat$hitc) && dat$hitc < 0) { + dat$coff <- dat$coff * -1 + } + + # compare data + if (!is.null(compare.dat$coff) && compare.dat$max_med < 0) { + compare.dat$coff <- compare.dat$coff * -1 + } + if (!is.null(compare.dat$coff) && !is.null(compare.dat$hitc) && compare.dat$hitc < 0) { + compare.dat$coff <- compare.dat$coff * -1 } } - - # check if data is outside bounds of yrange. If so, expand yrange bounds if (!identical(yrange, c(NA,NA))) { yrange[1] <- min(dat$resp_min, dat$coff, yrange[1], unlist(dat$resp), @@ -1160,7 +1206,7 @@ tcplggplotCompare <- function(dat, compare.dat, lvl = 5, verbose = FALSE, flags check_wllt <- function(data) { # check if dtxsid is NA, pull wllt in from lvl 3 if (is.na(data$dsstox_substance_id) | is.na(data$chnm)) { - wllt <- unique(tcplLoadData(lvl = 0, fld = list("spid","acid"), + wllt <- unique(tcplLoadData(type = ifelse(lvl == 2, "sc", "mc"), lvl = 0, fld = list("spid","acid"), list(data$spid, tcplLoadAcid(fld = "aeid", val = data$aeid)$acid))$wllt) if (length(wllt) == 1) { if (wllt == 'c' | wllt == 'p') { @@ -1189,14 +1235,21 @@ tcplggplotCompare <- function(dat, compare.dat, lvl = 5, verbose = FALSE, flags } } else { - warning(paste0("wllt for SPID: ", data$spid, " is missing or length > 1. + if (length(wllt) > 1) { + data$dsstox_substance_id <- paste0("Well type: ", paste(wllt, collapse = ", ")) + data$chnm <- "" + } else { + warning(paste0("wllt for SPID: ", data$spid, " is missing. Leaving dsstox_substance_id and chnm as NA.")) + } } } return(data) } - dat <- check_wllt(dat) - compare.dat <- check_wllt(compare.dat) + if (getOption("TCPL_DRVR") != "API") { + dat <- check_wllt(dat) + compare.dat <- check_wllt(compare.dat) + } dat$winning_model_string <- paste0("Model A(", dat$modl, ")") compare.dat$winning_model_string <- paste0("Model B(", compare.dat$modl, ")") diff --git a/R/tcplPlotUtils.R b/R/tcplPlotUtils.R index 2b15f3a4..dab8decd 100644 --- a/R/tcplPlotUtils.R +++ b/R/tcplPlotUtils.R @@ -1,13 +1,19 @@ tcplPlotLoadData <- function(lvl,fld, val, type,flags, compare = FALSE){ # check that input combination is unique - input <- tcplLoadData(lvl = lvl, fld = fld, val = val, type = type) - if (nrow(input) == 0) stop("No data for fld/val provided") + dat <- tcplLoadData(lvl = lvl, fld = fld, val = val, type = type)[, compare := compare] + if (nrow(dat) == 0) stop("No data for fld/val provided") + # set order to given order + dat <- dat[order(match(get(fld[1]), if(is.list(val)) val[[1]] else val))] + if (getOption("TCPL_DRVR") == "API" && tolower(fld) == "aeid") { + dat <- dat %>% arrange(m4id) + } + dat$order <- 1:nrow(dat) mcLoadDat <- function(m4id = NULL,flags) { l4 <- tcplLoadData(lvl = 4, fld = "m4id", val = m4id, add.fld = T) - dat <- l4[input, on = "m4id"] + dat <- l4[dat, on = "m4id"] if (flags == TRUE) { l6 <- tcplLoadData(lvl=6, fld='m4id', val=m4id, type='mc') if (nrow(l6) > 0) { @@ -21,46 +27,47 @@ tcplPlotLoadData <- function(lvl,fld, val, type,flags, compare = FALSE){ } dat <- dat[l6, on = "m4id"] } - tcplPrepOtpt(dat) - } - - scLoadDat <- function(s2id = NULL) { - tcplPrepOtpt(input) + dat } # load dat - if (type == "mc") { - dat <- mcLoadDat(input$m4id,flags = flags)[, compare := compare] - } else { # type == 'sc' - dat <- scLoadDat(input$s2id)[, compare := compare] + if (getOption("TCPL_DRVR") != "API") { + if (type == "mc") { + dat <- mcLoadDat(dat$m4id,flags = flags) + agg <- tcplLoadData(lvl = "agg", fld = "m4id", val = dat$m4id) + } else { # type == 'sc' + agg <- tcplLoadData(lvl = "agg", fld = "s2id", val = dat$s2id, type = "sc") + } + + # unlog concs + if (!("conc" %in% colnames(agg))) agg <- mutate(agg, conc = 10^logc) + + #determine if we're single conc or multiconc based on dat + join_condition <- c("m4id","s2id")[c("m4id","s2id") %in% colnames(dat)] + conc_resp_table <- agg %>% group_by(.data[[join_condition]]) %>% summarise(conc = list(conc), resp = list(resp)) %>% as.data.table() + dat <- dat[conc_resp_table, on = join_condition] + + dat <- tcplPrepOtpt(dat) + + } else { + # fix flags from API for plotting + if (flags == TRUE) { + if (is.null(dat$flag)) { + flag <- NA + } + dat <- dat %>% rowwise() %>% mutate(flag = ifelse(is.na(flag[1]) || flag[1] == "NULL" || is.null(flag[1]), "None", paste(flag, collapse = ';\n'))) %>% ungroup() %>% as.data.table() + } + dat$conc_unit <- dat$tested_conc_unit } # add normalized data type for y axis ndt <- tcplLoadAeid(fld = "aeid", val = dat$aeid, add.fld = "normalized_data_type") dat <- dat[ndt, on = "aeid"] - if("m4id" %in% colnames(dat)){ - agg <- tcplLoadData(lvl = "agg", fld = "m4id", val = dat$m4id) - } - if("s2id" %in% colnames(dat)){ - agg <- tcplLoadData(lvl = "agg", fld = "s2id", val = dat$s2id, type = "sc") - } - # unlog concs - if (!("conc" %in% colnames(agg))) agg <- mutate(agg, conc = 10^logc) - - #determine if we're single conc or multiconc based on dat - join_condition <- c("m4id","s2id")[c("m4id","s2id") %in% colnames(dat)] - conc_resp_table <- agg %>% group_by(.data[[join_condition]]) %>% summarise(conc = list(conc), resp = list(resp)) %>% as.data.table() - dat <- dat[conc_resp_table, on = join_condition] - # correct concentration unit label for x-axis dat <- dat[is.na(conc_unit), conc_unit:="\u03BCM"] dat <- dat[conc_unit=="uM", conc_unit:="\u03BCM"] dat <- dat[conc_unit=="mg/l", conc_unit:="mg/L"] - - # set order to given order - dat <- dat[order(match(get(fld[1]), val[[1]]))] - dat$order <- 1:nrow(dat) dat } @@ -215,4 +222,4 @@ tcplPlotSetYRange <- function(dat,yuniform,yrange,type){ } } } - \ No newline at end of file + diff --git a/R/tcplQueryAPI.R b/R/tcplQueryAPI.R index 0c5127a3..f7b6b412 100644 --- a/R/tcplQueryAPI.R +++ b/R/tcplQueryAPI.R @@ -6,6 +6,7 @@ #' #' @import data.table #' @importFrom ccdR get_bioactivity_details_batch get_all_assays +#' @importFrom tidyr unnest #' @export @@ -37,7 +38,7 @@ tcplQueryAPI <- function(resource = "data", fld = NULL, val = NULL, return_flds dat$dsstox_substance_id <- dat$dtxsid # unlist logc to conc - dat <- dat |> rowwise() |> mutate(conc = list(10^unlist(logc))) %>% as.data.table() + dat <- dat %>% rowwise() %>% mutate(conc = list(10^unlist(logc))) %>% as.data.table() } else if (resource == "assay") { diff --git a/man/tcplPlot.Rd b/man/tcplPlot.Rd index 1efae01d..a3548b7a 100644 --- a/man/tcplPlot.Rd +++ b/man/tcplPlot.Rd @@ -6,6 +6,7 @@ Generic Plotting Function for tcpl} \usage{ tcplPlot( + dat = NULL, type = "mc", fld = "m4id", val = NULL, diff --git a/vignettes/Data_retrieval_via_API.Rmd b/vignettes/Data_retrieval_via_API.Rmd new file mode 100644 index 00000000..bfaaf12a --- /dev/null +++ b/vignettes/Data_retrieval_via_API.Rmd @@ -0,0 +1,496 @@ +--- +title: Data Retrieval with tcpl via API +author: "Center for Computational Toxicology and Exposure, US EPA" +output: + prettydoc::html_pretty: + theme: architect + toc: yes + toc_depth: 4 +vignette: > + %\VignetteIndexEntry{Data Retrieval via API} + %\VignetteEngine{knitr::rmarkdown} + %\usepackage[utf8]{inputenc} +--- + +```{css, echo=FALSE} +.scroll-300 { + max-height: 300px; + overflow-y: auto; +} + +.noticebox { + padding: 1em; + background: lightgray; + color: blue; + border: 2px solid black; + border-radius: 10px; +} +``` + +```{r setup, include = FALSE} +devtools::load_all() +library(DT) +# helper function for printing +printFormattedTable <- function(res_dt, widen = c()) { + datatable(res_dt, style = 'bootstrap', class = 'table-bordered table-condensed', rownames = FALSE, options = list(scrollX = TRUE, autoWidth = TRUE, dom = 't', columnDefs = list(list(width = '1000px', targets = widen)))) +} +library(httptest) +start_vignette("api") +``` + +# Introduction + +This vignette describes how the user can retrieve ToxCast data (invitrodb) from the Computational Toxicology and Exposure APIs (CTX APIs) using tcpl. For more information on CTX APIs, review documentation available [here](https://www.epa.gov/comptox-tools/computational-toxicology-and-exposure-apis). tcpl interfaces with the CTX Bioactivity API through the R package ccdR (), which wraps the API endpoints and provides helpful functions for storing meta-information related to your connection. + +::: {.noticebox data-latex=""} + +**NOTE:** Users must have a personal API key for full functionality of many of these functions and executing the examples in this vignette. To obtain an API key, send an email request to . + +::: + +## Establishing API Connection + +After loading tcpl, the function tcplConf is used to establish connection to a database server or the API. While a typical database connection requires 5 parameters to be provided, using an API connection requires the user to only specify password (`pass`) and driver (`drvr`): + +```{r setup-api} +tcplConf(pass = "", + drvr = "API") +``` + +::: {.noticebox data-latex=""} + +**NOTE:** When tcpl is loaded, the default configuration sets the options to tcpl's application API key to support new users testing out the package. This default API key is not intended for regular users; instead, it is highly recommended to obtain a personal API key. For this, send an email request to . + +::: + +## Overview of Key Functions + +To support different ToxCast data retrieval needs, there are a number of tcpl functions that can be used to query the API and return information to a local R environment. + +Throughout this vignette, abbreviations may be used to refer to processing steps or data. Single-concentration 'SC' assay data is not currently available via API. ‘MC’ describes multiple-concentration assay data. A particular data or processing level is indicated by appending the level id/number to the end of the ‘SC’ or ‘MC’ designation. For example, multiple concentration data from level 3 processing uses the abbreviation ‘MC3.’ + +### Assay Elements + +The tcplLoadAsid, tcplLoadAid, tcplLoadAcid, and tcplLoadAeid functions load relevant ids and names for the respective assay elements based on the user specified parameters. + +```{r tcplLoad, eval = FALSE} +# List all assay source IDs +tcplLoadAsid() +# Create table of all assay endpoint ids (aeids) per assay source +aeids <- tcplLoadAeid(fld="asid", # field to query on + val=14, # value for each field + # values should match their corresponding 'fld' + add.fld = c("aid", "anm", "acid", "acnm")) # additional fields to return +``` + +### Data + +tcplQueryAPI is a general querying function which is flexible enough to handle most kinds of queries users may have for the API. Unlike tcplQuery, tcplQueryAPI does not accept a MySQL query but instead has a few arguments which can be set to mimic a request to the various API endpoints. tcplQueryAPI is used mostly as a helper function to other tcplLoad functions, but is available to users for more specific and/or personalized requests. + +```{r tcplQueryAPI, eval = FALSE} +# Request and load all assays+annotations for specified asid +data <- tcplQueryAPI(resource = "data", # resource to query from API, either 'data' or 'assay' + fld = "aeid", val = 891, # field and val to query on + return_fld = c("spid", "chnm", "hitcall")) # specify the return fields, leave NULL for all fields +``` + +The tcplLoadData function can be used to load data from the CTX APIs into the R environment. **Only MC levels 3, 4, 5, 6, and 'agg' are currently available via the API**. To add chemical and assay annotation information, and data from every level mapped to the retrieved data, set `add.fld = TRUE` (this is the default). The output with `add.fld = FALSE` will look as similar to the tcplLoadData output by level from a database connection, though some less known columns may not be available and the column order may differ. + +```{r tcplLoadData, eval=FALSE} +# Load multi concentration data from level 4 +mc4_dat <- tcplLoadData( + lvl = 4, # data level + fld = 'aeid', # field to query on + val = 891, # value for each field + # values should match their corresponding 'fld' + type = 'mc', # data type, default, not necessary + add.fld = FALSE # FALSE will only show fields/columns which are usually + # returned for this level, default TRUE will return all available + ) +``` + +When loading data, the user must indicate the applicable fields and ids which are query-able via the CTX Bioactivity API. These such fields are limited to "aeid", "m4id", "spid", and "dtxsid", and any other fields will result in error. While supplying multiple ids (through `val`) are valid, multiple fields are not. Combinations of fields are currently not supported with tcplLoadData using an API connection. tcplLoadData will return whatever data is found, and list in output if any val(s) were not found or contain no data to be returned. Examples of loading data are detailed in later sections. + +### Assay Annotations + +Assay source, assay, assay component, and assay endpoint are registered via tcpl scripting into a collection of database tables within invitrodb. For the API, these tables were joined to create a singular "assay" annotations view, which can be returned using tcplQueryAPI. The annotations capture four types of information: + +i. Identification information +ii. Design information such as the technology, format, and objective aspects that decompress the assay’s innovations +iii. Target information, such as the target of technological measurement, biological intended target, and biological process +iv. Analysis information about how the data were processed and analyzed + +```{r annotation_query_ex, eval = FALSE} +# load all assays and their annotations +assays <- tcplQueryAPI(resource = "assay") +``` + +# Retrieving Processed Multi-Concentration (MC) Data and Annotations + +As described in greater detail within the processing vignette, a goal of MC processing is to derive the efficacy and potency estimates for for each modeled endpoint-sample dose response. API data is available for levels 3 through 6, herein users can inspect the MC data including efficacy and potency estimates, model parameters, raw concentration response values, cautionary flags, and applied methods. + +## Data + +Loading data is can be done for a given endpoint (aeid), sample (spid), chemical (dtxsid), or endpoint-sample (m4id) by specifying "fld". Set add.fld = FALSE is used to limit fields to those which are defaults for each level when loading from invitrodb directly. Leaving add.fld = TRUE (default) will return all available fields, i.e. all information from levels 3 through 6. + +### By aeid +```{r data_by_aeid} +# Load Level 5 MC data for an aeid +mc5 <- tcplLoadData(lvl=5, # data level + fld="aeid", # fields to query on + val=704, # values should match their corresponding 'fld' + type = "mc", # data type, default, not needed + add.fld=FALSE) # restrict to just level 5 parameters +``` + +```{r, echo = FALSE} +printFormattedTable(mc5) +``` +### By spid +```{r data_by_spid} +# Load Level 5 MC data for an aeid +mc5 <- tcplLoadData(lvl=5, # data level + fld="spid", # fields to query on + val="TP0000904H05", # values should match their corresponding 'fld' + type = "mc", # data type, default, not needed + add.fld=FALSE) # restrict to just level 5 parameters +``` + +```{r, echo = FALSE} +printFormattedTable(mc5) +``` +### By m4id +```{r data_by_m4id} +# Load Level 5 MC data for an aeid +mc5 <- tcplLoadData(lvl=5, # data level + fld="m4id", # fields to query on + val=1842443, # values should match their corresponding 'fld' + type = "mc", # data type, default, not needed + add.fld=FALSE) # restrict to just level 5 parameters +``` + +```{r, echo = FALSE} +printFormattedTable(mc5) +``` +### By DTXSID +```{r data_by_dtxsid} +# Load Level 5 MC data for an aeid +mc5 <- tcplLoadData(lvl=5, # data level + fld="dtxsid", # fields to query on + val="DTXSID30944145", # values should match their corresponding 'fld' + type = "mc", # data type, default, not needed + add.fld=FALSE) # restrict to just level 5 parameters +``` + +```{r, echo = FALSE} +printFormattedTable(mc5) +``` +### By level + +In addition to level 5 data, levels 3, 4, 6, and 'agg' are available to pull from the API. + +#### mc3 + +```{r data_level_3} +mc3 <- tcplLoadData(lvl=3, # data level + fld="m4id", # fields to query on + val=1842443, # values should match their corresponding 'fld' + type = "mc", # data type, default, not needed + add.fld=FALSE) # restrict to just level 3 parameters +``` + +```{r, echo = FALSE} +printFormattedTable(mc3) +``` + +#### mc4 + +```{r data_level_4} +mc4 <- tcplLoadData(lvl=4, # data level + fld="m4id", # fields to query on + val=1842443, # values should match their corresponding 'fld' + type = "mc", # data type, default, not needed + add.fld=FALSE) # restrict to just level 4 parameters +``` + +```{r, echo = FALSE} +printFormattedTable(mc4) +``` + +#### mc6 + +```{r data_level_6} +mc6 <- tcplLoadData(lvl=6, # data level + fld="m4id", # fields to query on + val=1842443, # values should match their corresponding 'fld' + type = "mc", # data type, default, not needed + add.fld=FALSE) # restrict to just level 6 parameters +``` + +```{r, echo = FALSE} +printFormattedTable(mc6, 17) +``` + +#### agg + +```{r data_level_agg} +agg <- tcplLoadData(lvl="agg", # data level + fld="m4id", # fields to query on + val=1842443, # values should match their corresponding 'fld' + type = "mc", # data type, default, not needed + add.fld=FALSE) # restrict to just agg level parameters +``` + +```{r, echo = FALSE} +printFormattedTable(agg) +``` + +### add.fld = TRUE + +```{r data_level_5_all} +all_fields <- tcplLoadData(lvl=3, # data level + fld="m4id", # fields to query on + val=1842443, # values should match their corresponding 'fld' + type = "mc", # data type, default, not needed + add.fld=TRUE) # include all fields +``` + +```{r, echo = FALSE} +printFormattedTable(all_fields, 175) +``` + +## Assay Annotations + +The tcplLoadAsid, tcplLoadAid, tcplLoadAcid, and tcplLoadAeid functions load relevant assay ids and names for the respective assay elements based on the user specified parameters. + +### Load aeid + +tcplLoadAeid is used to load endpoint id (aeid) and endpoint name (aenm) as well any mapped annotations. Any annotations field can be used in the "fld" and "val" parameters to produce an annotations subset. Users may consider reviewing all annotations via tcplQueryAPI(resource = "assay") if unsure which values to supply. + +```{r load_aeid} +# load aeid and aenm for given acid +aeid <- tcplLoadAeid(fld = "acid", val = 400) +``` + +```{r, echo = FALSE} +printFormattedTable(aeid) +``` + +Users may subset on as many fields as desired. tcplLoadAeid joins the criteria with multiple `fld` and `val` as an “AND” rather than “OR”, meaning the subset returns rows where all are TRUE. `val` has the same length that `fld`. To combine fields of different types (i.e. numeric and string), or of different element lengths (list(“protein”, c(“Colorimetric”, “Fluorescence”))), ensure all values are provided in appropriate length lists. + +```{r load_aeid_plus} +# subset all aeids by using multiple fields -- val must be same length in list form! +aeids <- tcplLoadAeid(fld = c("intended_target_type", "detection_technology_type"), + val = list("protein", c("Colorimetric", "Fluorescence"))) # list length == 2! +``` + +```{r, echo = FALSE} +printFormattedTable(aeids) +``` + +### Load acid + +Similar to tcplLoadAeid, tcplLoadAcid loads assay component id (acid) and assay component name (acnm) as well as any specified annotation fields. Like tcplLoadAeid, output can be subset with as many `fld` and `val` as desired. + +```{r load_acid} +# load acid and acnm for given aeid +acid <- tcplLoadAcid(fld = "aeid", val = c(663,891)) +``` + +```{r, echo = FALSE} +printFormattedTable(acid) +``` + +```{r load_acid_all} +# subset all acids by using multiple fields -- val must be same length in list form! +acids <- tcplLoadAcid(fld = c("organism", "tissue"), + val = list("rat", "liver"), + add.fld = c("aeid", "aid", "asid", "signal_direction")) +``` + +```{r, echo = FALSE} +printFormattedTable(acids) +``` + +### Load aid + +Similar to tcplLoadAeid, tcplLoadAid loads assay id (aid) and assay name (anm) as well as any specified annotation fields. Like tcplLoadAeid, output can be subset with as many `fld` and `val` as desired. + +```{r load_aid} +# load aid and anm for given aeid +aid <- tcplLoadAid(fld = "aeid", val = 663) +``` + +```{r, echo = FALSE} +printFormattedTable(aid) +``` + +```{r load_aid_all} +# subset all aids by using multiple fields -- val must be same length in list form! +aids <- tcplLoadAid(fld = c("organism", "tissue"), + val = list("rat", "liver"), + add.fld = c("aeid", "acid", "asid", "signal_direction")) +``` + +```{r, echo = FALSE} +printFormattedTable(aids) +``` + +### Load asid + +Similar to tcplLoadAeid, tcplLoadAsid loads assay source id (asid) and assay source name (asnm) as well as any specified annotation fields. Like tcplLoadAsid, output can be subset with as many `fld` and `val` as desired. + +```{r load_asid} +# load asid and asnm for given aeid +asid <- tcplLoadAsid(fld = "aeid", val = 663) +``` + +```{r, echo = FALSE} +printFormattedTable(asid) +``` + +```{r load_asid_all} +# subset all asids by using multiple fields -- val must be same length in list form! +asids <- tcplLoadAsid(fld = c("organism", "tissue"), + val = list("rat", "liver"), + add.fld = c("aeid", "acid", "asid", "signal_direction")) +``` + +```{r, echo = FALSE} +printFormattedTable(asids) +``` + +### Load unit + +To load the normalized data type, or response unit, use tcplLoadUnit. This function does not require `fld` and `val` parameters, but uses `aeid` as input. tcplLoadUnit is typically used as an internal function for plotting. + +```{r load_unit} +# load resp_unit for given aeid +unit <- tcplLoadUnit(aeid = c(663, 891)) +``` + +```{r, echo = FALSE} +printFormattedTable(unit) +``` + +## Sample and Chemical information + +### Load concentration unit + +tcplLoadConcUnit is used to load the concentration unit for a specific `spid` or multiple `spid`s. This is typically used as an internal function for plotting. + +```{r load_conc_unit} +# load conc_unit for given spid +conc_unit <- tcplLoadConcUnit(spid = "TP0000904H05") +``` + +```{r, echo = FALSE} +printFormattedTable(conc_unit) +``` + +### Load chemical info + +tcplLoadChem is used to load the chemical information for a specific `spid` or multiple `spid`s. Notice tcplLoadChem uses `field` instead of `fld`. + +```{r load_chem} +# load chem_info for given spid +chem_info <- tcplLoadChem(field = "spid", val = "TP0000904H05") +``` + +```{r, echo = FALSE} +printFormattedTable(chem_info) +``` + +# Plotting + +tcplPlot is tcpl’s single flexible plotting function, allowing for interactive and consistent visualization of concentration-response curves via customizable parameters. For more details on implementation, parameters and specific customization instructions, refer to the main Data Retrieval vignette. This section will instead focus on the limitations of plotting using the CTX APIs as a data connection. + +As with loading data via tcplLoadData, the user must indicate the applicable fields and ids which are query-able via the CTX Bioactivity API. These such fields are limited to “aeid”, “m4id”, “spid”, and “dtxsid”, and any other fields input will result in error. + +While supplying multiple ids (through val) are valid, but multiple fields are not. For example, if fld = "spid", no aeid can be specified, meaning every matching spid will be plotted. If fld = "aeid", every sample within the given endpoint(s) will be plotted. If fld = "m4id", only one plot will output for every each m4id input. Combinations of fields are currently not supported with tcplPlot using API connections. Therefore, if looking for a specific aeid and spid combo, one should determine the corresponding m4id, like so: + +## Output Image File (JPG) of Single Verbose Plot, by M4ID + +```{r plot_aeid_spid, eval = FALSE} +# load all matching spids and then subset using the aeid desired to find m4id +mc5 <- tcplLoadData(lvl = 5, + fld = "spid", + val = "TP0000904H05", + type = "mc", + add.fld = FALSE) # 8 rows of data +m4id <- mc5[aeid == 714]$m4id # subset to 1 aeid extract m4id + +# default parameters used here: fld = "m4id", type = "mc" (type can never be "sc" when connected to API) +tcplPlot(val = m4id, output = "jpg", verbose = TRUE, flags = TRUE) +``` + +
![API-sourced plot with parameters: output = "jpg", verbose = TRUE, and flags = TRUE for m4id 1847540](img/API_plot_1847540.jpg)
+ +## Output PDF of Multiple Comparison Plots per Page, by M4ID + +The “compare"/dual-plot feature can be used by supplying a list of m4ids to `val` and `compare.val`. These lists must be the same length! + +```{r plot_m4id_compare, eval = FALSE} +# using the data pulled in the previous code chunk 'mc5' +m4id <- mc5$m4id # create m4id vector length == 8 + +# default parameters used here: fld = "m4id", type = "mc" (type can never be "sc" when connected to API) +tcplPlot(val = m4id[1:4], + compare.val = m4id[5:8], + output = "pdf", + verbose = TRUE, + multi = TRUE, + flags = TRUE, + yuniform = TRUE, + fileprefix = "API_plot_compare") +``` + +
![API-sourced plots with parameters: output = "pdf", verbose = TRUE, multi = TRUE, flags = TRUE, and yuniform = TRUE for m4ids 1833668, 1834094, 1836233, and 1836494, compared with m4ids 1839401, 1842443, 1847540, and 1850045](img/API_plot_compare.png)
+ +## Output PDF of Verbose, Multiple Plots per Page, by AEID + +Supply `fld = "aeid"` to plot every curve available in the API for the given endpoint(s). + +```{r plot_aeid, eval = FALSE} +# plot all curves across endpoint(s) +tcplPlot(fld = "aeid", + val = 704, + output = "pdf", + verbose = TRUE, + multi = TRUE, + yrange = c(-100,100), + fileprefix = "API_plot_704") +``` + +
![API-sourced plots with parameters: output = "pdf", verbose = TRUE, multi = TRUE, and yrange = c(-100,100) for aeid 704](img/API_plot_704.png)
+ +## Advanced Comparison Plotting + +tcplPlot has been updated for advanced comparison plotting across data connections. If working on a local invitrodb instance, additional dose-response data may be available, data reprocessed, methods adjusted, etc. Users may wish to compare data released in different versions, such as comparing API data or versioned database (invitrodb v4.1 and later) to one's local invitrodb database. + +Using the utility function tcplPlotLoadData while connected to the API, users can pass along data via tcplPlot’s `dat` parameter and use `compare.val` for their database data. + +```{r plot_standalone, eval = FALSE} +# while connected to the CTX Bioacivity API using tcplConf +api_data <- tcplPlotLoadData(lvl = 5, fld = "aeid", val = 704, type = "mc", flags = TRUE) + +# fill with database connection information +tcplConf(user="", pass="", db="", drvr="", host="") + +# add +tcplPlot(dat = api_data, + fld = "aeid", + val = 704, + compare.val = 704, + output = "pdf", + verbose = TRUE, + multi = TRUE, + flags = TRUE, + fileprefix = "API_plot_standalone") +``` + +
![API-sourced plots with parameters: dat = api_data from tcplPlotLoadData(), output = "pdf", verbose = TRUE, multi = TRUE, and flags = TRUE for comparison of aeid 704 to current database version](img/API_plot_standalone.png)
+ +```{r, include=FALSE} +end_vignette() +``` \ No newline at end of file diff --git a/vignettes/api/0/api-ccte.epa.gov/bioactivity/assay.json b/vignettes/api/0/api-ccte.epa.gov/bioactivity/assay.json new file mode 100644 index 00000000..39709efb --- /dev/null +++ b/vignettes/api/0/api-ccte.epa.gov/bioactivity/assay.json @@ -0,0 +1,109160 @@ +[ + { + "aeid": 2574, + "assayComponentEndpointName": "ERF_CR_ENZ_hELANE", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hELANE was analyzed at the assay endpoint, ERF_CR_ENZ_hELANE, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene ELANE. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is serine peptidase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "3',4'dichloroisocoumarin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "serine peptidase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2527, + "assayComponentName": "ERF_CR_ENZ_hELANE", + "assayComponentDesc": "ERF_CR_ENZ_hELANE is an assay component calculated from the ERF_CR_ENZ_hELANE assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by absorbance with spectrophotometry technology.", + "assayComponentTargetDesc": "Changes in absorbance produced from the regulation of catalytic activity reaction involving the key substrate, MeO-Suc-Ala-Ala-Pro-Val-p-Nitroanilide, are indicative of changes in enzyme function and kinetics related to the gene ELANE.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Colorimetric", + "detectionTechnologyTypeSub": "Absorbance ", + "detectionTechnology": "spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "MeO-Suc-Ala-Ala-Pro-Val-p-Nitroanilide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 729, + "assayName": "ERF_CR_ENZ_hELANE", + "assayDesc": "ERF_CR_ENZ_hELANE is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See Neutrophil Elastase Human Chymotrypsin Serine Peptidase Enzymatic Assay, Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human neutrophils", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 111, + "geneName": "elastase, neutrophil expressed", + "description": null, + "geneSymbol": "ELANE", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1991, + "officialSymbol": "ELANE", + "officialFullName": "elastase, neutrophil expressed", + "uniprotAccessionNumber": "P08246" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2575, + "assayComponentEndpointName": "ERF_CR_ENZ_hEPHA1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hEPHA1 was analyzed at the assay endpoint, ERF_CR_ENZ_hEPHA1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene EPHA1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2528, + "assayComponentName": "ERF_CR_ENZ_hEPHA1", + "assayComponentDesc": "ERF_CR_ENZ_hEPHA1 is an assay component calculated from the ERF_CR_ENZ_hEPHA1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with HTRF technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + biotinyl-beta Abeta Abeta AAEEEIYEEIEAKKK, are indicative of changes in receptor function and kinetics related to the gene EPHA1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HTRF", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + biotinyl-beta Abeta Abeta AAEEEIYEEIEAKKK", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 731, + "assayName": "ERF_CR_ENZ_hEPHA1", + "assayDesc": "ERF_CR_ENZ_hEPHA1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See EphA1 Human RTK Kinase Enzymatic HTRF Assay [Km ATP], Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 113, + "geneName": "EPH receptor A1", + "description": null, + "geneSymbol": "EPHA1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2041, + "officialSymbol": "EPHA1", + "officialFullName": "EPH receptor A1", + "uniprotAccessionNumber": "P21709" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2576, + "assayComponentEndpointName": "ERF_CR_ENZ_hEPHA2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hEPHA2 was analyzed at the assay endpoint, ERF_CR_ENZ_hEPHA2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene EPHA2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2529, + "assayComponentName": "ERF_CR_ENZ_hEPHA2", + "assayComponentDesc": "ERF_CR_ENZ_hEPHA2 is an assay component calculated from the ERF_CR_ENZ_hEPHA2 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-TK peptide , are indicative of changes in receptor function and kinetics related to the gene EPHA2.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-TK peptide ", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 790, + "assayName": "ERF_CR_ENZ_hEPHA2", + "assayDesc": "ERF_CR_ENZ_hEPHA2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See EphA2 Human RTK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 110, + "geneName": "EPH receptor A2", + "description": null, + "geneSymbol": "EPHA2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1969, + "officialSymbol": "EPHA2", + "officialFullName": "EPH receptor A2", + "uniprotAccessionNumber": "P29317" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2577, + "assayComponentEndpointName": "ERF_CR_ENZ_hEPHB2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hEPHB2 was analyzed at the assay endpoint, ERF_CR_ENZ_hEPHB2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene EPHB2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "PP2", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2530, + "assayComponentName": "ERF_CR_ENZ_hEPHB2", + "assayComponentDesc": "ERF_CR_ENZ_hEPHB2 is an assay component calculated from the ERF_CR_ENZ_hEPHB2 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-TK peptide, are indicative of changes in receptor function and kinetics related to the gene EPHB2.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-TK peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 789, + "assayName": "ERF_CR_ENZ_hEPHB2", + "assayDesc": "ERF_CR_ENZ_hEPHB2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See EphB2 Human RTK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 115, + "geneName": "EPH receptor B2", + "description": null, + "geneSymbol": "EPHB2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2048, + "officialSymbol": "EPHB2", + "officialFullName": "EPH receptor B2", + "uniprotAccessionNumber": "P29323" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2578, + "assayComponentEndpointName": "ERF_CR_ENZ_hFGFR1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hFGFR1 was analyzed at the assay endpoint, ERF_CR_ENZ_hFGFR1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene FGFR1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2531, + "assayComponentName": "ERF_CR_ENZ_hFGFR1", + "assayComponentDesc": "ERF_CR_ENZ_hFGFR1 is an assay component calculated from the ERF_CR_ENZ_hFGFR1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-CAGAGAIETDKEYYTVKD , are indicative of changes in receptor function and kinetics related to the gene FGFR1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-CAGAGAIETDKEYYTVKD ", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 770, + "assayName": "ERF_CR_ENZ_hFGFR1", + "assayDesc": "ERF_CR_ENZ_hFGFR1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See FGFR Human RTK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 126, + "geneName": "fibroblast growth factor receptor 1", + "description": null, + "geneSymbol": "FGFR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2260, + "officialSymbol": "FGFR1", + "officialFullName": "fibroblast growth factor receptor 1", + "uniprotAccessionNumber": "P11362" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2579, + "assayComponentEndpointName": "ERF_CR_ENZ_hFGFR3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hFGFR3 was analyzed at the assay endpoint, ERF_CR_ENZ_hFGFR3, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene FGFR3. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2532, + "assayComponentName": "ERF_CR_ENZ_hFGFR3", + "assayComponentDesc": "ERF_CR_ENZ_hFGFR3 is an assay component calculated from the ERF_CR_ENZ_hFGFR3 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-CAGAGAIETDKEYYTVKD, are indicative of changes in receptor function and kinetics related to the gene FGFR3.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-CAGAGAIETDKEYYTVKD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 775, + "assayName": "ERF_CR_ENZ_hFGFR3", + "assayDesc": "ERF_CR_ENZ_hFGFR3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.5 hour after chemical dosing in a 96-well plate. See FGFR3 Human RTK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 127, + "geneName": "fibroblast growth factor receptor 3", + "description": null, + "geneSymbol": "FGFR3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2261, + "officialSymbol": "FGFR3", + "officialFullName": "fibroblast growth factor receptor 3", + "uniprotAccessionNumber": "P22607" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2580, + "assayComponentEndpointName": "ERF_CR_ENZ_hFLT1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hFLT1 was analyzed at the assay endpoint, ERF_CR_ENZ_hFLT1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene FLT1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2533, + "assayComponentName": "ERF_CR_ENZ_hFLT1", + "assayComponentDesc": "ERF_CR_ENZ_hFLT1 is an assay component calculated from the ERF_CR_ENZ_hFLT1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-TK peptide, are indicative of changes in enzyme function and kinetics related to the gene FLT1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-TK peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 792, + "assayName": "ERF_CR_ENZ_hFLT1", + "assayDesc": "ERF_CR_ENZ_hFLT1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See Flt-1 (VEGFR1) Human RTK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant Sf9 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 131, + "geneName": "fms-related tyrosine kinase 1", + "description": null, + "geneSymbol": "FLT1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2321, + "officialSymbol": "FLT1", + "officialFullName": "fms-related tyrosine kinase 1", + "uniprotAccessionNumber": "P17948" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2581, + "assayComponentEndpointName": "ERF_CR_ENZ_hFLT4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hFLT4 was analyzed at the assay endpoint, ERF_CR_ENZ_hFLT4, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene FLT4. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2534, + "assayComponentName": "ERF_CR_ENZ_hFLT4", + "assayComponentDesc": "ERF_CR_ENZ_hFLT4 is an assay component calculated from the ERF_CR_ENZ_hFLT4 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-CAGAGAIETDKEYYTVKD, are indicative of changes in enzyme function and kinetics related to the gene FLT4.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-CAGAGAIETDKEYYTVKD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 776, + "assayName": "ERF_CR_ENZ_hFLT4", + "assayDesc": "ERF_CR_ENZ_hFLT4 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.5 hour after chemical dosing in a 96-well plate. See FLT4 Human RTK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 132, + "geneName": "fms-related tyrosine kinase 4", + "description": null, + "geneSymbol": "FLT4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2324, + "officialSymbol": "FLT4", + "officialFullName": "fms-related tyrosine kinase 4", + "uniprotAccessionNumber": "P35916" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2582, + "assayComponentEndpointName": "ERF_CR_ENZ_hFYN", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hFYN was analyzed at the assay endpoint, ERF_CR_ENZ_hFYN, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene FYN. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "PP1", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2535, + "assayComponentName": "ERF_CR_ENZ_hFYN", + "assayComponentDesc": "ERF_CR_ENZ_hFYN is an assay component calculated from the ERF_CR_ENZ_hFYN assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with HTRF technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + biotinyl-beta Abeta Abeta AYQAEENTYDEYEN, are indicative of changes in enzyme function and kinetics related to the gene FYN.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HTRF", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + biotinyl-beta Abeta Abeta AYQAEENTYDEYEN", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 747, + "assayName": "ERF_CR_ENZ_hFYN", + "assayDesc": "ERF_CR_ENZ_hFYN is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See Fyn Human TK Kinase Enzymatic HTRF Assay [Km ATP], Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 137, + "geneName": "FYN proto-oncogene, Src family tyrosine kinase", + "description": null, + "geneSymbol": "FYN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2534, + "officialSymbol": "FYN", + "officialFullName": "FYN proto-oncogene, Src family tyrosine kinase", + "uniprotAccessionNumber": "P06241" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2583, + "assayComponentEndpointName": "ERF_CR_ENZ_hGSK3b", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hGSK3b was analyzed at the assay endpoint, ERF_CR_ENZ_hGSK3b, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene GSK3B. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2536, + "assayComponentName": "ERF_CR_ENZ_hGSK3b", + "assayComponentDesc": "ERF_CR_ENZ_hGSK3b is an assay component calculated from the ERF_CR_ENZ_hGSK3b assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-CFFKNIVTPRTPPPSQGK-amide , are indicative of changes in enzyme function and kinetics related to the gene GSK3B.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-CFFKNIVTPRTPPPSQGK-amide ", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 773, + "assayName": "ERF_CR_ENZ_hGSK3b", + "assayDesc": "ERF_CR_ENZ_hGSK3b is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.5 hour after chemical dosing in a 96-well plate. See GSK3beta Human CMGC Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 146, + "geneName": "glycogen synthase kinase 3 beta", + "description": null, + "geneSymbol": "GSK3B", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2932, + "officialSymbol": "GSK3B", + "officialFullName": "glycogen synthase kinase 3 beta", + "uniprotAccessionNumber": "P49841" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2584, + "assayComponentEndpointName": "ERF_CR_ENZ_hHDAC6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hHDAC6 was analyzed at the assay endpoint, ERF_CR_ENZ_hHDAC6, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene HDAC6. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the epigenetic enzyme intended target family, where the subfamily is histone deacetylase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "trichostatin A", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "epigenetic enzyme", + "intendedTargetFamilySub": "histone deacetylase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2537, + "assayComponentName": "ERF_CR_ENZ_hHDAC6", + "assayComponentDesc": "ERF_CR_ENZ_hHDAC6 is an assay component calculated from the ERF_CR_ENZ_hHDAC6 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with fluorimetry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, fluorogenic HDAC substrate, are indicative of changes in enzyme function and kinetics related to the gene HDAC6.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorimetry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorogenic HDAC substrate", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 756, + "assayName": "ERF_CR_ENZ_hHDAC6", + "assayDesc": "ERF_CR_ENZ_hHDAC6 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See HDAC6 Human Histone Deacetylase (HDAC) Enzymatic Assay, Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 361, + "geneName": "histone deacetylase 6", + "description": null, + "geneSymbol": "HDAC6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10013, + "officialSymbol": "HDAC6", + "officialFullName": "histone deacetylase 6", + "uniprotAccessionNumber": "Q9UBN7" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2585, + "assayComponentEndpointName": "ERF_CR_ENZ_hIRAK4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hIRAK4 was analyzed at the assay endpoint, ERF_CR_ENZ_hIRAK4, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene IRAK4. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2538, + "assayComponentName": "ERF_CR_ENZ_hIRAK4", + "assayComponentDesc": "ERF_CR_ENZ_hIRAK4 is an assay component calculated from the ERF_CR_ENZ_hIRAK4 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-FLGFTYVAP, are indicative of changes in enzyme function and kinetics related to the gene IRAK4.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-FLGFTYVAP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 784, + "assayName": "ERF_CR_ENZ_hIRAK4", + "assayDesc": "ERF_CR_ENZ_hIRAK4 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.5 hour after chemical dosing in a 96-well plate. See IRAK4 Human TKL Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 425, + "geneName": "interleukin-1 receptor-associated kinase 4", + "description": null, + "geneSymbol": "IRAK4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 51135, + "officialSymbol": "IRAK4", + "officialFullName": "interleukin-1 receptor-associated kinase 4", + "uniprotAccessionNumber": "Q9NWZ3" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2586, + "assayComponentEndpointName": "ERF_CR_ENZ_hJAK2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hJAK2 was analyzed at the assay endpoint, ERF_CR_ENZ_hJAK2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene JAK2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2539, + "assayComponentName": "ERF_CR_ENZ_hJAK2", + "assayComponentDesc": "ERF_CR_ENZ_hJAK2 is an assay component calculated from the ERF_CR_ENZ_hJAK2 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-CAGAGAIETDKEYYTVKD, are indicative of changes in enzyme function and kinetics related to the gene JAK2.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-CAGAGAIETDKEYYTVKD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 771, + "assayName": "ERF_CR_ENZ_hJAK2", + "assayDesc": "ERF_CR_ENZ_hJAK2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See JAK2 Human TK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant Sf21 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 182, + "geneName": "Janus kinase 2", + "description": null, + "geneSymbol": "JAK2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3717, + "officialSymbol": "JAK2", + "officialFullName": "Janus kinase 2", + "uniprotAccessionNumber": "O60674" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2587, + "assayComponentEndpointName": "ERF_CR_ENZ_hKDR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hKDR was analyzed at the assay endpoint, ERF_CR_ENZ_hKDR, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene KDR. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2540, + "assayComponentName": "ERF_CR_ENZ_hKDR", + "assayComponentDesc": "ERF_CR_ENZ_hKDR is an assay component calculated from the ERF_CR_ENZ_hKDR assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-CAGAGAIETDKEYYTVKD, are indicative of changes in enzyme function and kinetics related to the gene KDR.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-CAGAGAIETDKEYYTVKD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 767, + "assayName": "ERF_CR_ENZ_hKDR", + "assayDesc": "ERF_CR_ENZ_hKDR is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See KDR (VEGFR2) Human RTK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant Sf9 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 186, + "geneName": "kinase insert domain receptor (a type III receptor tyrosine kinase)", + "description": null, + "geneSymbol": "KDR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3791, + "officialSymbol": "KDR", + "officialFullName": "kinase insert domain receptor (a type III receptor tyrosine kinase)", + "uniprotAccessionNumber": "P35968" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2588, + "assayComponentEndpointName": "ERF_CR_ENZ_hLCK", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hLCK was analyzed at the assay endpoint, ERF_CR_ENZ_hLCK, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene LCK. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2541, + "assayComponentName": "ERF_CR_ENZ_hLCK", + "assayComponentDesc": "ERF_CR_ENZ_hLCK is an assay component calculated from the ERF_CR_ENZ_hLCK assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-Poly GAT[EAY(1:1:1)]n, are indicative of changes in enzyme function and kinetics related to the gene LCK.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-Poly GAT[EAY(1:1:1)]n", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 778, + "assayName": "ERF_CR_ENZ_hLCK", + "assayDesc": "ERF_CR_ENZ_hLCK is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.16 hour after chemical dosing in a 96-well plate. See Lck Human TK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.16, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 188, + "geneName": "LCK proto-oncogene, Src family tyrosine kinase", + "description": null, + "geneSymbol": "LCK", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3932, + "officialSymbol": "LCK", + "officialFullName": "LCK proto-oncogene, Src family tyrosine kinase", + "uniprotAccessionNumber": "P06239" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2589, + "assayComponentEndpointName": "ERF_CR_ENZ_hLYN", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hLYN was analyzed at the assay endpoint, ERF_CR_ENZ_hLYN, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene LYN. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2542, + "assayComponentName": "ERF_CR_ENZ_hLYN", + "assayComponentDesc": "ERF_CR_ENZ_hLYN is an assay component calculated from the ERF_CR_ENZ_hLYN assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with HTRF technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + His-tagged Rb truncated protein, are indicative of changes in enzyme function and kinetics related to the gene LYN.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HTRF", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + His-tagged Rb truncated protein", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 750, + "assayName": "ERF_CR_ENZ_hLYN", + "assayDesc": "ERF_CR_ENZ_hLYN is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See LYN (B) Human TK Kinase Enzymatic HTRF Assay [Km ATP], Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 195, + "geneName": "LYN proto-oncogene, Src family tyrosine kinase", + "description": null, + "geneSymbol": "LYN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4067, + "officialSymbol": "LYN", + "officialFullName": "LYN proto-oncogene, Src family tyrosine kinase", + "uniprotAccessionNumber": "P07948" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2590, + "assayComponentEndpointName": "ERF_CR_ENZ_hMAOA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hMAOA was analyzed at the assay endpoint, ERF_CR_ENZ_hMAOA, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene MAOA. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the stress response intended target family, where the subfamily is monoamine oxidase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "clorgiline", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "stress response", + "intendedTargetFamilySub": "monoamine oxidase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2543, + "assayComponentName": "ERF_CR_ENZ_hMAOA", + "assayComponentDesc": "ERF_CR_ENZ_hMAOA is an assay component calculated from the ERF_CR_ENZ_hMAOA assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with spectrophotometry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, kynuramine, are indicative of changes in enzyme function and kinetics related to the gene MAOA.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Colorimetric", + "detectionTechnologyTypeSub": "Absorbance ", + "detectionTechnology": "spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "kynuramine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 732, + "assayName": "ERF_CR_ENZ_hMAOA", + "assayDesc": "ERF_CR_ENZ_hMAOA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.33 hour after chemical dosing in a 96-well plate. See Monoamine Oxidase A (MAO-A) Human Enzymatic Assay, Cerep.", + "timepointHr": 0.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 4645, + "geneName": "monoamine oxidase A", + "description": null, + "geneSymbol": "MAOA", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 4128, + "officialSymbol": "MAOA", + "officialFullName": "monoamine oxidase A", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2591, + "assayComponentEndpointName": "ERF_CR_ENZ_hMAOB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hMAOB was analyzed at the assay endpoint, ERF_CR_ENZ_hMAOB, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene MAOB. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the stress response intended target family, where the subfamily is monoamine oxidase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "deprenyl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "stress response", + "intendedTargetFamilySub": "monoamine oxidase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2544, + "assayComponentName": "ERF_CR_ENZ_hMAOB", + "assayComponentDesc": "ERF_CR_ENZ_hMAOB is an assay component calculated from the ERF_CR_ENZ_hMAOB assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by luminescent intensity with luminescence technology.", + "assayComponentTargetDesc": "Changes in luminescent intensity produced from the regulation of catalytic activity reaction involving the key substrate, D-Luciferin derivative, are indicative of changes in enzyme function and kinetics related to the gene MAOB.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Luminescence intensity", + "detectionTechnology": "Luciferase", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "D-Luciferin derivative", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 800, + "assayName": "ERF_CR_ENZ_hMAOB", + "assayDesc": "ERF_CR_ENZ_hMAOB is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See Monoamine Oxidase B (MAO-B) Human Enzymatic Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 4646, + "geneName": "monoamine oxidase B", + "description": null, + "geneSymbol": "MAOB", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 4129, + "officialSymbol": "MAOB", + "officialFullName": "monoamine oxidase B", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2592, + "assayComponentEndpointName": "ERF_CR_ENZ_hMAPK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hMAPK1 was analyzed at the assay endpoint, ERF_CR_ENZ_hMAPK1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene MAPK1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2545, + "assayComponentName": "ERF_CR_ENZ_hMAPK1", + "assayComponentDesc": "ERF_CR_ENZ_hMAPK1 is an assay component calculated from the ERF_CR_ENZ_hMAPK1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-CFFKNIVTPRTPPPSQGK-amide, are indicative of changes in enzyme function and kinetics related to the gene MAPK1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-CFFKNIVTPRTPPPSQGK-amide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 772, + "assayName": "ERF_CR_ENZ_hMAPK1", + "assayDesc": "ERF_CR_ENZ_hMAPK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See ERK2 (MAPK1) Human CMGC Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 259, + "geneName": "mitogen-activated protein kinase 1", + "description": null, + "geneSymbol": "MAPK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5594, + "officialSymbol": "MAPK1", + "officialFullName": "mitogen-activated protein kinase 1", + "uniprotAccessionNumber": "P28482" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2593, + "assayComponentEndpointName": "ERF_KP_ENZ_hMAPK11", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_KP_ENZ_hMAPK11 was analyzed at the assay endpoint, ERF_KP_ENZ_hMAPK11, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene MAPK11. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "PP1 Analog II. 1NM-PP1", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2546, + "assayComponentName": "ERF_KP_ENZ_hMAPK11", + "assayComponentDesc": "ERF_KP_ENZ_hMAPK11 is an assay component calculated from the ERF_KP_ENZ_hMAPK11 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, myelin basic protein, are indicative of changes in enzyme function and kinetics related to the gene MAPK11.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "myelin basic protein", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 701, + "assayName": "ERF_KP_ENZ_hMAPK11", + "assayDesc": "ERF_KP_ENZ_hMAPK11 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.66 hour after chemical dosing in a 96-well plate. See SAPK2 (p38beta) Human CMGC Kinase Enzymatic Radiometric Assay [10 uM ATP], KinaseProfiler.", + "timepointHr": 0.66, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human full length recombinant", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 261, + "geneName": "mitogen-activated protein kinase 11", + "description": null, + "geneSymbol": "MAPK11", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5600, + "officialSymbol": "MAPK11", + "officialFullName": "mitogen-activated protein kinase 11", + "uniprotAccessionNumber": "Q15759" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2594, + "assayComponentEndpointName": "ERF_CR_ENZ_hMAPKAPK2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hMAPKAPK2 was analyzed at the assay endpoint, ERF_CR_ENZ_hMAPKAPK2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene MAPKAPK2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2547, + "assayComponentName": "ERF_CR_ENZ_hMAPKAPK2", + "assayComponentDesc": "ERF_CR_ENZ_hMAPKAPK2 is an assay component calculated from the ERF_CR_ENZ_hMAPKAPK2 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + CREBtide, are indicative of changes in enzyme function and kinetics related to the gene MAPKAPK2.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + CREBtide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 799, + "assayName": "ERF_CR_ENZ_hMAPKAPK2", + "assayDesc": "ERF_CR_ENZ_hMAPKAPK2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See MAPKAPK2 Human CAMK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 352, + "geneName": "mitogen-activated protein kinase-activated protein kinase 2", + "description": null, + "geneSymbol": "MAPKAPK2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9261, + "officialSymbol": "MAPKAPK2", + "officialFullName": "mitogen-activated protein kinase-activated protein kinase 2", + "uniprotAccessionNumber": "P49137" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2595, + "assayComponentEndpointName": "ERF_PL_ENZ_hMAPKAPK5", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_hMAPKAPK5 was analyzed at the assay endpoint, ERF_PL_ENZ_hMAPKAPK5, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene MAPKAPK5. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2548, + "assayComponentName": "ERF_PL_ENZ_hMAPKAPK5", + "assayComponentDesc": "ERF_PL_ENZ_hMAPKAPK5 is an assay component calculated from the ERF_PL_ENZ_hMAPKAPK5 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, PRAK substrate peptide, are indicative of changes in enzyme function and kinetics related to the gene MAPKAPK5.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "PRAK substrate peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 725, + "assayName": "ERF_PL_ENZ_hMAPKAPK5", + "assayDesc": "ERF_PL_ENZ_hMAPKAPK5 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See PRAK Human CAMK Kinase Enzymatic Radiometric Assay [10 uM ATP], Panlabs.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant Sf21 insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 343, + "geneName": "mitogen-activated protein kinase-activated protein kinase 5", + "description": null, + "geneSymbol": "MAPKAPK5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8550, + "officialSymbol": "MAPKAPK5", + "officialFullName": "mitogen-activated protein kinase-activated protein kinase 5", + "uniprotAccessionNumber": "Q8IW41" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2596, + "assayComponentEndpointName": "ERF_CR_ENZ_hMARK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hMARK1 was analyzed at the assay endpoint, ERF_CR_ENZ_hMARK1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene MARK1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2549, + "assayComponentName": "ERF_CR_ENZ_hMARK1", + "assayComponentDesc": "ERF_CR_ENZ_hMARK1 is an assay component calculated from the ERF_CR_ENZ_hMARK1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-RRRSLLE, are indicative of changes in enzyme function and kinetics related to the gene MARK1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-RRRSLLE", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 796, + "assayName": "ERF_CR_ENZ_hMARK1", + "assayDesc": "ERF_CR_ENZ_hMARK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See MARK1 Human CAMK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 198, + "geneName": "MAP/microtubule affinity-regulating kinase 1", + "description": null, + "geneSymbol": "MARK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4139, + "officialSymbol": "MARK1", + "officialFullName": "MAP/microtubule affinity-regulating kinase 1", + "uniprotAccessionNumber": "Q9P0L2" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2597, + "assayComponentEndpointName": "ERF_CR_ENZ_hMET", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hMET was analyzed at the assay endpoint, ERF_CR_ENZ_hMET, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene MET. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2550, + "assayComponentName": "ERF_CR_ENZ_hMET", + "assayComponentDesc": "ERF_CR_ENZ_hMET is an assay component calculated from the ERF_CR_ENZ_hMET assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-CAGAGAIETDKEYYTVKD, are indicative of changes in receptor function and kinetics related to the gene MET.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-CAGAGAIETDKEYYTVKD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 769, + "assayName": "ERF_CR_ENZ_hMET", + "assayDesc": "ERF_CR_ENZ_hMET is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See Met Human RTK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 200, + "geneName": "MET proto-oncogene, receptor tyrosine kinase", + "description": null, + "geneSymbol": "MET", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4233, + "officialSymbol": "MET", + "officialFullName": "MET proto-oncogene, receptor tyrosine kinase", + "uniprotAccessionNumber": "P08581" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2598, + "assayComponentEndpointName": "ERF_CR_ENZ_hMMP3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hMMP3 was analyzed at the assay endpoint, ERF_CR_ENZ_hMMP3, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene MMP3. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metallopeptidase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ilomastat", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metallopeptidase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2551, + "assayComponentName": "ERF_CR_ENZ_hMMP3", + "assayComponentDesc": "ERF_CR_ENZ_hMMP3 is an assay component calculated from the ERF_CR_ENZ_hMMP3 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with fluorimetry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, NFF-2 , are indicative of changes in enzyme function and kinetics related to the gene MMP3.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorimetry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NFF-2 ", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 823, + "assayName": "ERF_CR_ENZ_hMMP3", + "assayDesc": "ERF_CR_ENZ_hMMP3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See MMP3 Human Matrix Metallopeptidase Enzymatic Assay, Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 205, + "geneName": "matrix metallopeptidase 3 (stromelysin 1, progelatinase)", + "description": null, + "geneSymbol": "MMP3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4314, + "officialSymbol": "MMP3", + "officialFullName": "matrix metallopeptidase 3 (stromelysin 1, progelatinase)", + "uniprotAccessionNumber": "P08254" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2599, + "assayComponentEndpointName": "ERF_CR_ENZ_hMMP9", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hMMP9 was analyzed at the assay endpoint, ERF_CR_ENZ_hMMP9, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene MMP9. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metallopeptidase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ilomastat", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metallopeptidase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2552, + "assayComponentName": "ERF_CR_ENZ_hMMP9", + "assayComponentDesc": "ERF_CR_ENZ_hMMP9 is an assay component calculated from the ERF_CR_ENZ_hMMP9 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with fluorimetry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, NFF-2 , are indicative of changes in enzyme function and kinetics related to the gene MMP9.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorimetry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NFF-2 ", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 824, + "assayName": "ERF_CR_ENZ_hMMP9", + "assayDesc": "ERF_CR_ENZ_hMMP9 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.5 hour after chemical dosing in a 96-well plate. See MMP9 Human Matrix Metallopeptidase Enzymatic Assay, Cerep.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 207, + "geneName": "matrix metallopeptidase 9 (gelatinase B, 92kDa gelatinase, 92kDa type IV collagenase)", + "description": null, + "geneSymbol": "MMP9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4318, + "officialSymbol": "MMP9", + "officialFullName": "matrix metallopeptidase 9 (gelatinase B, 92kDa gelatinase, 92kDa type IV collagenase)", + "uniprotAccessionNumber": "P14780" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2600, + "assayComponentEndpointName": "ERF_CR_ENZ_hMSK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hMSK1 was analyzed at the assay endpoint, ERF_CR_ENZ_hMSK1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene MSK1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2553, + "assayComponentName": "ERF_CR_ENZ_hMSK1", + "assayComponentDesc": "ERF_CR_ENZ_hMSK1 is an assay component calculated from the ERF_CR_ENZ_hMSK1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, Histone H3 full length, are indicative of changes in enzyme function and kinetics related to the gene RPS6KA5.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Histone H3 full length", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 805, + "assayName": "ERF_CR_ENZ_hMSK1", + "assayDesc": "ERF_CR_ENZ_hMSK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.16 hour after chemical dosing in a 96-well plate. See MSK1 Human AGC Kinase Enzymatic Radiometric Assay [Km ATP], Cerep.", + "timepointHr": 0.16, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 351, + "geneName": "ribosomal protein S6 kinase, 90kDa, polypeptide 5", + "description": null, + "geneSymbol": "RPS6KA5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9252, + "officialSymbol": "RPS6KA5", + "officialFullName": "ribosomal protein S6 kinase, 90kDa, polypeptide 5", + "uniprotAccessionNumber": "O75582" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2601, + "assayComponentEndpointName": "ERF_CR_ENZ_hNEK2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hNEK2 was analyzed at the assay endpoint, ERF_CR_ENZ_hNEK2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene NEK2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2554, + "assayComponentName": "ERF_CR_ENZ_hNEK2", + "assayComponentDesc": "ERF_CR_ENZ_hNEK2 is an assay component calculated from the ERF_CR_ENZ_hNEK2 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-FLGFTYVAP, are indicative of changes in enzyme function and kinetics related to the gene NEK2.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-FLGFTYVAP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 785, + "assayName": "ERF_CR_ENZ_hNEK2", + "assayDesc": "ERF_CR_ENZ_hNEK2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See NEK2 Human Other Protein Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 215, + "geneName": "NIMA-related kinase 2", + "description": null, + "geneSymbol": "NEK2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4751, + "officialSymbol": "NEK2", + "officialFullName": "NIMA-related kinase 2", + "uniprotAccessionNumber": "P51955" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2602, + "assayComponentEndpointName": "ERF_CR_ENZ_hNTRK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hNTRK1 was analyzed at the assay endpoint, ERF_CR_ENZ_hNTRK1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene NTRK1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2555, + "assayComponentName": "ERF_CR_ENZ_hNTRK1", + "assayComponentDesc": "ERF_CR_ENZ_hNTRK1 is an assay component calculated from the ERF_CR_ENZ_hNTRK1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-Poly GAT[EAY(1:1:1)]n, are indicative of changes in enzyme function and kinetics related to the gene NTRK1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-Poly GAT[EAY(1:1:1)]n", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 777, + "assayName": "ERF_CR_ENZ_hNTRK1", + "assayDesc": "ERF_CR_ENZ_hNTRK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.16 hour after chemical dosing in a 96-well plate. See TRKA Human RTK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.16, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 222, + "geneName": "neurotrophic tyrosine kinase, receptor, type 1", + "description": null, + "geneSymbol": "NTRK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4914, + "officialSymbol": "NTRK1", + "officialFullName": "neurotrophic tyrosine kinase, receptor, type 1", + "uniprotAccessionNumber": "P04629" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2603, + "assayComponentEndpointName": "ERF_CR_ENZ_hPAK4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hPAK4 was analyzed at the assay endpoint, ERF_CR_ENZ_hPAK4, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene PAK4. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2556, + "assayComponentName": "ERF_CR_ENZ_hPAK4", + "assayComponentDesc": "ERF_CR_ENZ_hPAK4 is an assay component calculated from the ERF_CR_ENZ_hPAK4 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-RRRSLLE, are indicative of changes in enzyme function and kinetics related to the gene PAK4.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-RRRSLLE", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 797, + "assayName": "ERF_CR_ENZ_hPAK4", + "assayDesc": "ERF_CR_ENZ_hPAK4 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See PAK4 Human STE Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 364, + "geneName": "p21 protein (Cdc42/Rac)-activated kinase 4", + "description": null, + "geneSymbol": "PAK4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10298, + "officialSymbol": "PAK4", + "officialFullName": "p21 protein (Cdc42/Rac)-activated kinase 4", + "uniprotAccessionNumber": "O96013" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2604, + "assayComponentEndpointName": "ERF_CR_ENZ_hPDE10A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hPDE10A was analyzed at the assay endpoint, ERF_CR_ENZ_hPDE10A, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene PDE10A. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphodiesterase intended target family, where the subfamily is cyclic nucleotide signaling.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "papaverine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2557, + "assayComponentName": "ERF_CR_ENZ_hPDE10A", + "assayComponentDesc": "ERF_CR_ENZ_hPDE10A is an assay component calculated from the ERF_CR_ENZ_hPDE10A assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, [3H]cAMP + cAMP, are indicative of changes in enzyme function and kinetics related to the gene PDE10A.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "[3H]cAMP + cAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 813, + "assayName": "ERF_CR_ENZ_hPDE10A", + "assayDesc": "ERF_CR_ENZ_hPDE10A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.33 hour after chemical dosing in a 96-well plate. See PDE10A2 Human Phosphodiesterase Enzymatic Assay, Cerep.", + "timepointHr": 0.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant Sf9 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 368, + "geneName": "phosphodiesterase 10A", + "description": null, + "geneSymbol": "PDE10A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10846, + "officialSymbol": "PDE10A", + "officialFullName": "phosphodiesterase 10A", + "uniprotAccessionNumber": "Q9Y233" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2605, + "assayComponentEndpointName": "ERF_CR_ENZ_hPDE4A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hPDE4A was analyzed at the assay endpoint, ERF_CR_ENZ_hPDE4A, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene PDE4A. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphodiesterase intended target family, where the subfamily is cyclic nucleotide signaling.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ro 20-1724", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2558, + "assayComponentName": "ERF_CR_ENZ_hPDE4A", + "assayComponentDesc": "ERF_CR_ENZ_hPDE4A is an assay component calculated from the ERF_CR_ENZ_hPDE4A assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, [3H]cAMP + cAMP, are indicative of changes in enzyme function and kinetics related to the gene PDE4A.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "[3H]cAMP + cAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 811, + "assayName": "ERF_CR_ENZ_hPDE4A", + "assayDesc": "ERF_CR_ENZ_hPDE4A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.33 hour after chemical dosing in a 96-well plate. See PDE4A1A Human Phosphodiesterase Enzymatic Assay, Cerep.", + "timepointHr": 0.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant Sf9 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 232, + "geneName": "phosphodiesterase 4A, cAMP-specific", + "description": null, + "geneSymbol": "PDE4A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5141, + "officialSymbol": "PDE4A", + "officialFullName": "phosphodiesterase 4A, cAMP-specific", + "uniprotAccessionNumber": "P27815" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2606, + "assayComponentEndpointName": "ERF_PL_ENZ_hPDE4D2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_hPDE4D2 was analyzed at the assay endpoint, ERF_PL_ENZ_hPDE4D2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene PDE4D. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "rolipram", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2559, + "assayComponentName": "ERF_PL_ENZ_hPDE4D2", + "assayComponentDesc": "ERF_PL_ENZ_hPDE4D2 is an assay component calculated from the ERF_PL_ENZ_hPDE4D2 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with spectrophotometry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, FAM-cAMP, are indicative of changes in enzyme function and kinetics related to the gene PDE4D.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Colorimetric", + "detectionTechnologyTypeSub": "Absorbance ", + "detectionTechnology": "spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "FAM-cAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 712, + "assayName": "ERF_PL_ENZ_hPDE4D2", + "assayDesc": "ERF_PL_ENZ_hPDE4D2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See PDE4D2 Human Phosphodiesterase Enzymatic Assay, Panlabs.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect Sf9 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 5360, + "geneName": "phosphodiesterase 4D", + "description": null, + "geneSymbol": "PDE4D", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5144, + "officialSymbol": "PDE4D", + "officialFullName": "phosphodiesterase 4D", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2607, + "assayComponentEndpointName": "ERF_KP_ENZ_hPKD2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_KP_ENZ_hPKD2 was analyzed at the assay endpoint, ERF_KP_ENZ_hPKD2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene PRKD2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2560, + "assayComponentName": "ERF_KP_ENZ_hPKD2", + "assayComponentDesc": "ERF_KP_ENZ_hPKD2 is an assay component calculated from the ERF_KP_ENZ_hPKD2 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, KKLNRTLSVA, are indicative of changes in enzyme function and kinetics related to the gene PRKD2.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "KKLNRTLSVA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 702, + "assayName": "ERF_KP_ENZ_hPKD2", + "assayDesc": "ERF_KP_ENZ_hPKD2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.66 hour after chemical dosing in a 96-well plate. See PKD2 Human Protein Ser/Thr Kinase Enzymatic Radiometric Assay [10 uM ATP], KinaseProfiler.", + "timepointHr": 0.66, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human full length recombinant", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 416, + "geneName": "protein kinase D2", + "description": null, + "geneSymbol": "PRKD2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 25865, + "officialSymbol": "PRKD2", + "officialFullName": "protein kinase D2", + "uniprotAccessionNumber": "Q9BZL6" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2608, + "assayComponentEndpointName": "ERF_KP_ENZ_hPRKAA1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_KP_ENZ_hPRKAA1 was analyzed at the assay endpoint, ERF_KP_ENZ_hPRKAA1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene PRKAA1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2561, + "assayComponentName": "ERF_KP_ENZ_hPRKAA1", + "assayComponentDesc": "ERF_KP_ENZ_hPRKAA1 is an assay component calculated from the ERF_KP_ENZ_hPRKAA1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, AMARAASAAALAR, are indicative of changes in enzyme function and kinetics related to the gene PRKAA1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "AMARAASAAALAR", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 705, + "assayName": "ERF_KP_ENZ_hPRKAA1", + "assayDesc": "ERF_KP_ENZ_hPRKAA1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.66 hour after chemical dosing in a 96-well plate. See AMPKalpha1 Human CAMK Kinase Enzymatic Radiometric Assay [10 uM ATP], KinaseProfiler.", + "timepointHr": 0.66, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human full length recombinant", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 255, + "geneName": "protein kinase, AMP-activated, alpha 1 catalytic subunit", + "description": null, + "geneSymbol": "PRKAA1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5562, + "officialSymbol": "PRKAA1", + "officialFullName": "protein kinase, AMP-activated, alpha 1 catalytic subunit", + "uniprotAccessionNumber": "Q13131" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2609, + "assayComponentEndpointName": "ERF_PL_ENZ_hPRKACA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_hPRKACA was analyzed at the assay endpoint, ERF_PL_ENZ_hPRKACA, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene PRKACA. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1-(5-ISOQUINOLINESULFONYL)-2-M", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2562, + "assayComponentName": "ERF_PL_ENZ_hPRKACA", + "assayComponentDesc": "ERF_PL_ENZ_hPRKACA is an assay component calculated from the ERF_PL_ENZ_hPRKACA assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, PKA substrate peptide, are indicative of changes in enzyme function and kinetics related to the gene PRKACA.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "PKA substrate peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 727, + "assayName": "ERF_PL_ENZ_hPRKACA", + "assayDesc": "ERF_PL_ENZ_hPRKACA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See PKA Human AGC Kinase Enzymatic Radiometric Assay [10 uM ATP], Panlabs.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 256, + "geneName": "protein kinase, cAMP-dependent, catalytic, alpha", + "description": null, + "geneSymbol": "PRKACA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5566, + "officialSymbol": "PRKACA", + "officialFullName": "protein kinase, cAMP-dependent, catalytic, alpha", + "uniprotAccessionNumber": "P17612" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2610, + "assayComponentEndpointName": "ERF_PL_ENZ_hPRKCZ", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_hPRKCZ was analyzed at the assay endpoint, ERF_PL_ENZ_hPRKCZ, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene PRKCZ. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2563, + "assayComponentName": "ERF_PL_ENZ_hPRKCZ", + "assayComponentDesc": "ERF_PL_ENZ_hPRKCZ is an assay component calculated from the ERF_PL_ENZ_hPRKCZ assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, histone, are indicative of changes in enzyme function and kinetics related to the gene PRKCZ.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "histone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 730, + "assayName": "ERF_PL_ENZ_hPRKCZ", + "assayDesc": "ERF_PL_ENZ_hPRKCZ is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See PKCzeta Human PKC Kinase Enzymatic Radiometric Assay [10 uM ATP], Panlabs.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect Sf21 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 258, + "geneName": "protein kinase C, zeta", + "description": null, + "geneSymbol": "PRKCZ", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5590, + "officialSymbol": "PRKCZ", + "officialFullName": "protein kinase C, zeta", + "uniprotAccessionNumber": "Q05513" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2611, + "assayComponentEndpointName": "ERF_PL_ENZ_hPTEN", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_hPTEN was analyzed at the assay endpoint, ERF_PL_ENZ_hPTEN, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene PTEN. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is dual-specific phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "(NH4)6Mo7O24", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "dual-specific phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2564, + "assayComponentName": "ERF_PL_ENZ_hPTEN", + "assayComponentDesc": "ERF_PL_ENZ_hPTEN is an assay component calculated from the ERF_PL_ENZ_hPTEN assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with spectrophotometry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, DiFMUP, are indicative of changes in enzyme function and kinetics related to the gene PTEN.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Colorimetric", + "detectionTechnologyTypeSub": "Absorbance ", + "detectionTechnology": "spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "DiFMUP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 733, + "assayName": "ERF_PL_ENZ_hPTEN", + "assayDesc": "ERF_PL_ENZ_hPTEN is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See PTEN Human Phosphatase Enzymatic Assay, Panlabs.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 263, + "geneName": "phosphatase and tensin homolog", + "description": null, + "geneSymbol": "PTEN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5728, + "officialSymbol": "PTEN", + "officialFullName": "phosphatase and tensin homolog", + "uniprotAccessionNumber": "P60484" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2612, + "assayComponentEndpointName": "ERF_CR_ENZ_hPTGS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hPTGS2 was analyzed at the assay endpoint, ERF_CR_ENZ_hPTGS2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene PTGS2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the stress response intended target family, where the subfamily is cyclooxygenase.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "ns-398", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "stress response", + "intendedTargetFamilySub": "cyclooxygenase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2565, + "assayComponentName": "ERF_CR_ENZ_hPTGS2", + "assayComponentDesc": "ERF_CR_ENZ_hPTGS2 is an assay component calculated from the ERF_CR_ENZ_hPTGS2 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with fluorimetry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate;substrate, arachidonic acid; ADHP, are indicative of changes in enzyme function and kinetics related to the gene PTGS2.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorimetry", + "keyAssayReagentType": "substrate;substrate", + "keyAssayReagent": "arachidonic acid; ADHP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 817, + "assayName": "ERF_CR_ENZ_hPTGS2", + "assayDesc": "ERF_CR_ENZ_hPTGS2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.083 hour after chemical dosing in a 96-well plate. See COX2 Human Cyclooxygenase Enzymatic Assay, Cerep.", + "timepointHr": 0.083, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 5831, + "geneName": "prostaglandin-endoperoxide synthase 2", + "description": null, + "geneSymbol": "PTGS2", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5743, + "officialSymbol": "PTGS2", + "officialFullName": "prostaglandin-endoperoxide synthase 2", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2613, + "assayComponentEndpointName": "ERF_CR_ENZ_hPTPN11", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hPTPN11 was analyzed at the assay endpoint, ERF_CR_ENZ_hPTPN11, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene PTPN11. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is protein tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "sodium orthovanadate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "protein tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2566, + "assayComponentName": "ERF_CR_ENZ_hPTPN11", + "assayComponentDesc": "ERF_CR_ENZ_hPTPN11 is an assay component calculated from the ERF_CR_ENZ_hPTPN11 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with spectrophotometry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, 6,8-difluoro-4, are indicative of changes in enzyme function and kinetics related to the gene PTPN11.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Colorimetric", + "detectionTechnologyTypeSub": "Absorbance ", + "detectionTechnology": "spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "6,8-difluoro-4", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 704, + "assayName": "ERF_CR_ENZ_hPTPN11", + "assayDesc": "ERF_PL_ENZ_hPTPN11 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See SHP2 Human Phosphatase Enzymatic Assay, PhosphataseProfiler.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 270, + "geneName": "protein tyrosine phosphatase, non-receptor type 11", + "description": null, + "geneSymbol": "PTPN11", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5781, + "officialSymbol": "PTPN11", + "officialFullName": "protein tyrosine phosphatase, non-receptor type 11", + "uniprotAccessionNumber": "Q06124" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2614, + "assayComponentEndpointName": "ERF_CR_ENZ_hPTPRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hPTPRB was analyzed at the assay endpoint, ERF_CR_ENZ_hPTPRB, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene PTPRB. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is protein tyrosine phosphatase.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "protein tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2567, + "assayComponentName": "ERF_CR_ENZ_hPTPRB", + "assayComponentDesc": "ERF_CR_ENZ_hPTPRB is an assay component calculated from the ERF_CR_ENZ_hPTPRB assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with spectrophotometry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, 6,8-difluoro-5, are indicative of changes in enzyme function and kinetics related to the gene PTPRB.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Colorimetric", + "detectionTechnologyTypeSub": "Absorbance ", + "detectionTechnology": "spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "6,8-difluoro-5", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 706, + "assayName": "ERF_CR_ENZ_hPTPRB", + "assayDesc": "ERF_PL_ENZ_hPTPRB is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See PTPbeta Human Phosphatase Enzymatic Assay, PhosphataseProfiler.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 274, + "geneName": "protein tyrosine phosphatase, receptor type, B", + "description": null, + "geneSymbol": "PTPRB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5787, + "officialSymbol": "PTPRB", + "officialFullName": "protein tyrosine phosphatase, receptor type, B", + "uniprotAccessionNumber": "P23467" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2615, + "assayComponentEndpointName": "ERF_PL_ENZ_hPTPRF", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_hPTPRF was analyzed at the assay endpoint, ERF_PL_ENZ_hPTPRF, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene PTPRF. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "(NH4)6Mo7O24", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2568, + "assayComponentName": "ERF_PL_ENZ_hPTPRF", + "assayComponentDesc": "ERF_PL_ENZ_hPTPRF is an assay component calculated from the ERF_PL_ENZ_hPTPRF assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with spectrophotometry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, DiFMUP, are indicative of changes in enzyme function and kinetics related to the gene PTPRF.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Colorimetric", + "detectionTechnologyTypeSub": "Absorbance ", + "detectionTechnology": "spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "DiFMUP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 734, + "assayName": "ERF_PL_ENZ_hPTPRF", + "assayDesc": "ERF_PL_ENZ_hPTPRF is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See LAR Human Phosphatase Enzymatic Assay, Panlabs.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 276, + "geneName": "protein tyrosine phosphatase, receptor type, F", + "description": null, + "geneSymbol": "PTPRF", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5792, + "officialSymbol": "PTPRF", + "officialFullName": "protein tyrosine phosphatase, receptor type, F", + "uniprotAccessionNumber": "P10586" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2617, + "assayComponentEndpointName": "ERF_CR_ENZ_hRAF1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hRAF1 was analyzed at the assay endpoint, ERF_CR_ENZ_hRAF1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene RAF1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2570, + "assayComponentName": "ERF_CR_ENZ_hRAF1", + "assayComponentDesc": "ERF_CR_ENZ_hRAF1 is an assay component calculated from the ERF_CR_ENZ_hRAF1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with HTRF technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + inactive MEK1, are indicative of changes in enzyme function and kinetics related to the gene RAF1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HTRF", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + inactive MEK1", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 724, + "assayName": "ERF_CR_ENZ_hRAF1", + "assayDesc": "ERF_CR_ENZ_hRAF1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See c-Raf (Raf-1) Human TKL Kinase Enzymatic HTRF Assay [Km ATP], Cerep.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 278, + "geneName": "Raf-1 proto-oncogene, serine/threonine kinase", + "description": null, + "geneSymbol": "RAF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5894, + "officialSymbol": "RAF1", + "officialFullName": "Raf-1 proto-oncogene, serine/threonine kinase", + "uniprotAccessionNumber": "P04049" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2618, + "assayComponentEndpointName": "ERF_CR_ENZ_hROCK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hROCK1 was analyzed at the assay endpoint, ERF_CR_ENZ_hROCK1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene ROCK1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2571, + "assayComponentName": "ERF_CR_ENZ_hROCK1", + "assayComponentDesc": "ERF_CR_ENZ_hROCK1 is an assay component calculated from the ERF_CR_ENZ_hROCK1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-RRRSLLE, are indicative of changes in enzyme function and kinetics related to the gene ROCK1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-RRRSLLE", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 798, + "assayName": "ERF_CR_ENZ_hROCK1", + "assayDesc": "ERF_CR_ENZ_hROCK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.33 hour after chemical dosing in a 96-well plate. See ROCK1 Human AGC Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 283, + "geneName": "Rho-associated, coiled-coil containing protein kinase 1", + "description": null, + "geneSymbol": "ROCK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6093, + "officialSymbol": "ROCK1", + "officialFullName": "Rho-associated, coiled-coil containing protein kinase 1", + "uniprotAccessionNumber": "Q13464" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2619, + "assayComponentEndpointName": "ERF_CR_ENZ_hSGK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hSGK1 was analyzed at the assay endpoint, ERF_CR_ENZ_hSGK1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene SGK1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2572, + "assayComponentName": "ERF_CR_ENZ_hSGK1", + "assayComponentDesc": "ERF_CR_ENZ_hSGK1 is an assay component calculated from the ERF_CR_ENZ_hSGK1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-RRRSLLE , are indicative of changes in enzyme function and kinetics related to the gene SGK1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-RRRSLLE ", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 783, + "assayName": "ERF_CR_ENZ_hSGK1", + "assayDesc": "ERF_CR_ENZ_hSGK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See SGK1 Human AGC Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 295, + "geneName": "serum/glucocorticoid regulated kinase 1", + "description": null, + "geneSymbol": "SGK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6446, + "officialSymbol": "SGK1", + "officialFullName": "serum/glucocorticoid regulated kinase 1", + "uniprotAccessionNumber": "O00141" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2620, + "assayComponentEndpointName": "ERF_CR_ENZ_hSIRT3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hSIRT3 was analyzed at the assay endpoint, ERF_CR_ENZ_hSIRT3, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene SIRT3. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the epigenetic enzyme intended target family, where the subfamily is histone deacetylase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "nicotinamide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "epigenetic enzyme", + "intendedTargetFamilySub": "histone deacetylase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2573, + "assayComponentName": "ERF_CR_ENZ_hSIRT3", + "assayComponentDesc": "ERF_CR_ENZ_hSIRT3 is an assay component calculated from the ERF_CR_ENZ_hSIRT3 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with fluorimetry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, fluoro-lysine sirtuin 2 deacetylase substrate, are indicative of changes in enzyme function and kinetics related to the gene SIRT3.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorimetry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluoro-lysine sirtuin 2 deacetylase substrate", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 761, + "assayName": "ERF_CR_ENZ_hSIRT3", + "assayDesc": "ERF_CR_ENZ_hSIRT3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.75 hour after chemical dosing in a 96-well plate. See Sirtuin 3 Human Histone Deacetylase (HDAC) Enzymatic Antagonist Assay, Cerep.", + "timepointHr": 0.75, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 376, + "geneName": "sirtuin 3", + "description": null, + "geneSymbol": "SIRT3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 23410, + "officialSymbol": "SIRT3", + "officialFullName": "sirtuin 3", + "uniprotAccessionNumber": "Q9NTG7" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2621, + "assayComponentEndpointName": "ERF_CR_ENZ_hSRC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hSRC was analyzed at the assay endpoint, ERF_CR_ENZ_hSRC, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene SRC. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2574, + "assayComponentName": "ERF_CR_ENZ_hSRC", + "assayComponentDesc": "ERF_CR_ENZ_hSRC is an assay component calculated from the ERF_CR_ENZ_hSRC assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-Poly GAT[EAY(1:1:1)]n, are indicative of changes in enzyme function and kinetics related to the gene SRC.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-Poly GAT[EAY(1:1:1)]n", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 779, + "assayName": "ERF_CR_ENZ_hSRC", + "assayDesc": "ERF_CR_ENZ_hSRC is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.16 hour after chemical dosing in a 96-well plate. See Src Human TK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.16, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 303, + "geneName": "SRC proto-oncogene, non-receptor tyrosine kinase", + "description": null, + "geneSymbol": "SRC", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6714, + "officialSymbol": "SRC", + "officialFullName": "SRC proto-oncogene, non-receptor tyrosine kinase", + "uniprotAccessionNumber": "P12931" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2622, + "assayComponentEndpointName": "ERF_CR_ENZ_hSYK", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hSYK was analyzed at the assay endpoint, ERF_CR_ENZ_hSYK, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene SYK. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is spleen tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "spleen tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2575, + "assayComponentName": "ERF_CR_ENZ_hSYK", + "assayComponentDesc": "ERF_CR_ENZ_hSYK is an assay component calculated from the ERF_CR_ENZ_hSYK assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-CAGAGAIETDKEYYTVKD, are indicative of changes in enzyme function and kinetics related to the gene SYK.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-CAGAGAIETDKEYYTVKD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 765, + "assayName": "ERF_CR_ENZ_hSYK", + "assayDesc": "ERF_CR_ENZ_hSYK is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See Syk Human TK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 308, + "geneName": "spleen tyrosine kinase", + "description": null, + "geneSymbol": "SYK", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6850, + "officialSymbol": "SYK", + "officialFullName": "spleen tyrosine kinase", + "uniprotAccessionNumber": "P43405" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2623, + "assayComponentEndpointName": "ERF_CR_ENZ_hZAP70", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hZAP70 was analyzed at the assay endpoint, ERF_CR_ENZ_hZAP70, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene ZAP70. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is protein tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "protein tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2576, + "assayComponentName": "ERF_CR_ENZ_hZAP70", + "assayComponentDesc": "ERF_CR_ENZ_hZAP70 is an assay component calculated from the ERF_CR_ENZ_hZAP70 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with HTRF technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + biotinyl- beta Abeta Abeta ADEEEYFIPP, are indicative of changes in enzyme function and kinetics related to the gene ZAP70.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HTRF", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + biotinyl- beta Abeta Abeta ADEEEYFIPP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 832, + "assayName": "ERF_CR_ENZ_hZAP70", + "assayDesc": "ERF_CR_ENZ_hZAP70 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See ZAP70 Human TK Kinase Enzymatic HTRF Assay [Km ATP], Cerep.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 338, + "geneName": "zeta-chain (TCR) associated protein kinase 70kDa", + "description": null, + "geneSymbol": "ZAP70", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7535, + "officialSymbol": "ZAP70", + "officialFullName": "zeta-chain (TCR) associated protein kinase 70kDa", + "uniprotAccessionNumber": "P43403" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2624, + "assayComponentEndpointName": "ERF_CR_ENZ_rACFSK_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_rACFSK_Agonist was analyzed at the assay endpoint, ERF_CR_ENZ_rACFSK_Agonist, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene ADCY5. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is adenylyl cyclase.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "cAMP", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "adenylyl cyclase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2577, + "assayComponentName": "ERF_CR_ENZ_rACFSK_Agonist", + "assayComponentDesc": "ERF_CR_ENZ_rACFSK_Agonist is an assay component calculated from the ERF_CR_ENZ_rACFSK assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with HTRF technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the receptor binding reaction involving the key ligand, [3H]-forskolin, are indicative of changes in enzyme function and kinetics related to the gene ADCY5.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HTRF", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-forskolin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 786, + "assayName": "ERF_CR_ENZ_rACFSK_Agonist", + "assayDesc": "ERF_CR_ENZ_rACFSK_Agonist is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.16 hour after chemical dosing in a 96-well plate. See Adenylyl Cyclase Hamster Enzymatic Agonist Assay, Cerep.", + "timepointHr": 0.16, + "organismId": null, + "organism": "hamster", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "CHO", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 433, + "geneName": "adenylate cyclase 5", + "description": null, + "geneSymbol": "Adcy5", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 64532, + "officialSymbol": "Adcy5", + "officialFullName": "adenylate cyclase 5", + "uniprotAccessionNumber": "Q04400" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2625, + "assayComponentEndpointName": "ERF_CR_ENZ_rACFSK_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_rACFSK_Antagonist was analyzed at the assay endpoint, ERF_CR_ENZ_rACFSK_Antagonist, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene ADCY5. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is adenylyl cyclase.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "cAMP", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "adenylyl cyclase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2578, + "assayComponentName": "ERF_CR_ENZ_rACFSK_Antagonist", + "assayComponentDesc": "ERF_CR_ENZ_rACFSK_Antagonist is an assay component calculated from the ERF_CR_ENZ_rACFSK assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with HTRF technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the receptor binding reaction involving the key ligand, [3H]-forskolin, are indicative of changes in enzyme function and kinetics related to the gene ADCY5.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HTRF", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-forskolin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 787, + "assayName": "ERF_CR_ENZ_rACFSK_Antagonist", + "assayDesc": "ERF_CR_ENZ_rACFSK_Antagonist is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.16 hour after chemical dosing in a 96-well plate. See Adenylyl Cyclase Hamster Enzymatic Antagonist Assay, Cerep.", + "timepointHr": 0.16, + "organismId": null, + "organism": "hamster", + "tissue": "brain", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "CHO", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 433, + "geneName": "adenylate cyclase 5", + "description": null, + "geneSymbol": "Adcy5", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 64532, + "officialSymbol": "Adcy5", + "officialFullName": "adenylate cyclase 5", + "uniprotAccessionNumber": "Q04400" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2626, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_g5HT4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_g5HT4 was analyzed at the assay endpoint, ERF_PL_GPCR_binding_g5HT4, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in radioligand binding as they relate to gene HTR4 (homolog). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is serotonin.", + "assayFunctionType": "radioligand binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "CHEMBL83954", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "serotonin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2579, + "assayComponentName": "ERF_PL_GPCR_binding_g5HT4", + "assayComponentDesc": "ERF_PL_GPCR_binding_g5HT4 is an assay component calculated from the ERF_PL_GPCR_binding_g5HT4 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-GR-113808, are indicative of changes in receptor function and kinetics related to the gene HTR4 (homolog).", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-GR-113808", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 764, + "assayName": "ERF_PL_GPCR_g5HT4", + "assayDesc": "ERF_PL_GPCR_g5HT4 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See 5-HT4 Guinea Pig Serotonin GPCR Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 0.5, + "organismId": 10141, + "organism": "guinea pig", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "guinea pig striatal membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 471, + "geneName": "5 hydroxytryptamine (serotonin) receptor 4", + "description": "provisional", + "geneSymbol": "Htr4", + "organismId": 10, + "trackStatus": "live", + "entrezGeneId": 100135548, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "O70528" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2627, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_gANPA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_gANPA was analyzed at the assay endpoint, ERF_PL_GPCR_binding_gANPA, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene ANPA. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is guanylyl cyclase.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "ANF (rat)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "guanylyl cyclase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2580, + "assayComponentName": "ERF_PL_GPCR_binding_gANPA", + "assayComponentDesc": "ERF_PL_GPCR_binding_gANPA is an assay component calculated from the ERF_PL_GPCR_binding_gANPA assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [125I]Atrial Natriuretic Factor (ANF) rat, are indicative of changes in receptor function and kinetics related to the gene ANPA.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]Atrial Natriuretic Factor (ANF) rat", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 746, + "assayName": "ERF_PL_GPCR_gANPA", + "assayDesc": "ERF_PL_GPCR_gANPA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See Atrial Natriuretic Factor (ANF, Non-Selective) Guinea Pig Binding Assay, Panlabs.", + "timepointHr": 1.0, + "organismId": 10141, + "organism": "guinea pig", + "tissue": "kidney", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "adrenal gland membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 472, + "geneName": "natriuretic peptide A", + "description": "model", + "geneSymbol": "Nppa", + "organismId": 10, + "trackStatus": "live", + "entrezGeneId": 100135578, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P27596" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2628, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hADORA1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hADORA1 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hADORA1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene ADORA1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is adenosine.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "CPA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "adenosine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2581, + "assayComponentName": "ERF_CR_GPCR_binding_hADORA1", + "assayComponentDesc": "ERF_CR_GPCR_binding_hADORA1 is an assay component calculated from the ERF_CR_GPCR_binding_hADORA1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-8-Cyclopentyl-1,3-dipropylxanthine (CCPA), are indicative of changes in receptor function and kinetics related to the gene ADORA1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-8-Cyclopentyl-1,3-dipropylxanthine (CCPA)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 820, + "assayName": "ERF_CR_GPCR_hADORA1", + "assayDesc": "ERF_CR_GPCR_hADORA1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See A1 Human Adenosine GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 10, + "geneName": "adenosine A1 receptor", + "description": null, + "geneSymbol": "ADORA1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 134, + "officialSymbol": "ADORA1", + "officialFullName": "adenosine A1 receptor", + "uniprotAccessionNumber": "P30542" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2629, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hADORA2A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hADORA2A was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hADORA2A, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene ADORA2A. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is adenosine.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NECA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "adenosine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2582, + "assayComponentName": "ERF_CR_GPCR_binding_hADORA2A", + "assayComponentDesc": "ERF_CR_GPCR_binding_hADORA2A is an assay component calculated from the ERF_CR_GPCR_binding_hADORA2A assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-CGS 21680, are indicative of changes in receptor function and kinetics related to the gene ADORA2A.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-CGS 21680", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 810, + "assayName": "ERF_CR_GPCR_hADORA2A", + "assayDesc": "ERF_CR_GPCR_hADORA2A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See A2A Human Adenosine GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 11, + "geneName": "adenosine A2a receptor", + "description": null, + "geneSymbol": "ADORA2A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 135, + "officialSymbol": "ADORA2A", + "officialFullName": "adenosine A2a receptor", + "uniprotAccessionNumber": "P29274" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2630, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hADRA1A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hADRA1A was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hADRA1A, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene ADRA1A. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is adrenoceptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "WB-4101", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "adrenoceptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2583, + "assayComponentName": "ERF_CR_GPCR_binding_hADRA1A", + "assayComponentDesc": "ERF_CR_GPCR_binding_hADRA1A is an assay component calculated from the ERF_CR_GPCR_binding_hADRA1A assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Prazosin, are indicative of changes in receptor function and kinetics related to the gene ADRA1A.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Prazosin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 753, + "assayName": "ERF_CR_GPCR_hADRA1A", + "assayDesc": "ERF_CR_GPCR_hADRA1A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See alpha1A Human Adrenoceptor GPCR Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 483, + "geneName": "adrenoceptor alpha 1A", + "description": null, + "geneSymbol": "ADRA1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 148, + "officialSymbol": "ADRA1A", + "officialFullName": "adrenoceptor alpha 1A", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2631, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_hADRA2A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_hADRA2A was analyzed at the assay endpoint, ERF_PL_GPCR_binding_hADRA2A, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in radioligand binding as they relate to gene ADRA2A. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is adrenoceptor.", + "assayFunctionType": "radioligand binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "yohimbine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor ", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "adrenoceptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2584, + "assayComponentName": "ERF_PL_GPCR_binding_hADRA2A", + "assayComponentDesc": "ERF_PL_GPCR_binding_hADRA2A is an assay component calculated from the ERF_PL_GPCR_binding_hADRA2A assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, rauwolscine, are indicative of changes in receptor function and kinetics related to the gene ADRA2A.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "rauwolscine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 738, + "assayName": "ERF_PL_GPCR_hADRA2A", + "assayDesc": "ERF_PL_GPCR_hADRA2A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See alpha2A Human Adrenoceptor GPCR Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO-K1 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 13, + "geneName": "adrenoceptor alpha 2A", + "description": null, + "geneSymbol": "ADRA2A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 150, + "officialSymbol": "ADRA2A", + "officialFullName": "adrenoceptor alpha 2A", + "uniprotAccessionNumber": "P08913" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2632, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_hADRA2C", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_hADRA2C was analyzed at the assay endpoint, ERF_PL_GPCR_binding_hADRA2C, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in radioligand binding as they relate to gene ADRA2C. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is adrenoceptor.", + "assayFunctionType": "radioligand binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "yohimbine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor ", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "adrenoceptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2585, + "assayComponentName": "ERF_PL_GPCR_binding_hADRA2C", + "assayComponentDesc": "ERF_PL_GPCR_binding_hADRA2C is an assay component calculated from the ERF_PL_GPCR_binding_hADRA2C assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, rauwolscine, are indicative of changes in receptor function and kinetics related to the gene ADRA2C.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "rauwolscine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 739, + "assayName": "ERF_PL_GPCR_hADRA2C", + "assayDesc": "ERF_PL_GPCR_hADRA2C is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See alpha2C Human Adrenoceptor GPCR Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO-K1 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 14, + "geneName": "adrenoceptor alpha 2C", + "description": null, + "geneSymbol": "ADRA2C", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 152, + "officialSymbol": "ADRA2C", + "officialFullName": "adrenoceptor alpha 2C", + "uniprotAccessionNumber": "P18825" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2633, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_hADRB1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_hADRB1 was analyzed at the assay endpoint, ERF_PL_GPCR_binding_hADRB1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in radioligand binding as they relate to gene ADRB1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is adrenoceptor.", + "assayFunctionType": "radioligand binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "S(-)-Propranolol", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor ", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "adrenoceptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2586, + "assayComponentName": "ERF_PL_GPCR_binding_hADRB1", + "assayComponentDesc": "ERF_PL_GPCR_binding_hADRB1 is an assay component calculated from the ERF_PL_GPCR_binding_hADRB1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [125I] Cyanopindolol, are indicative of changes in receptor function and kinetics related to the gene ADRB1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I] Cyanopindolol", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 740, + "assayName": "ERF_PL_GPCR_hADRB1", + "assayDesc": "ERF_PL_GPCR_hADRB1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See beta1 Human Adrenoceptor GPCR Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO-K1 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 15, + "geneName": "adrenoceptor beta 1", + "description": null, + "geneSymbol": "ADRB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 153, + "officialSymbol": "ADRB1", + "officialFullName": "adrenoceptor beta 1", + "uniprotAccessionNumber": "P08588" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2634, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hADRB2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hADRB2 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hADRB2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene ADRB2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is adrenoceptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "ICI 118551", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "adrenoceptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2587, + "assayComponentName": "ERF_CR_GPCR_binding_hADRB2", + "assayComponentDesc": "ERF_CR_GPCR_binding_hADRB2 is an assay component calculated from the ERF_CR_GPCR_binding_hADRB2 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H](-)CGP 12177, are indicative of changes in receptor function and kinetics related to the gene ADRB2.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H](-)CGP 12177", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 736, + "assayName": "ERF_CR_GPCR_hADRB2", + "assayDesc": "ERF_CR_GPCR_hADRB2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See beta2 Human Adrenoceptor GPCR Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 16, + "geneName": "adrenoceptor beta 2, surface", + "description": null, + "geneSymbol": "ADRB2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 154, + "officialSymbol": "ADRB2", + "officialFullName": "adrenoceptor beta 2, surface", + "uniprotAccessionNumber": "P07550" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2635, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_hADRB3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_hADRB3 was analyzed at the assay endpoint, ERF_PL_GPCR_binding_hADRB3, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in radioligand binding as they relate to gene ADRB3. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is adrenoceptor.", + "assayFunctionType": "radioligand binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "alprenolol ", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor ", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "adrenoceptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2588, + "assayComponentName": "ERF_PL_GPCR_binding_hADRB3", + "assayComponentDesc": "ERF_PL_GPCR_binding_hADRB3 is an assay component calculated from the ERF_PL_GPCR_binding_hADRB3 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, cyanopindolol, are indicative of changes in receptor function and kinetics related to the gene ADRB3.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "cyanopindolol", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 741, + "assayName": "ERF_PL_GPCR_hADRB3", + "assayDesc": "ERF_PL_GPCR_hADRB3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.5 hour after chemical dosing in a 96-well plate. See beta3 Human Adrenoceptor GPCR Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant HEK-293 cells", + "cellShortName": "HEK293", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 17, + "geneName": "adrenoceptor beta 3", + "description": null, + "geneSymbol": "ADRB3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 155, + "officialSymbol": "ADRB3", + "officialFullName": "adrenoceptor beta 3", + "uniprotAccessionNumber": "P13945" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2636, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_hAGTR1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_hAGTR1 was analyzed at the assay endpoint, ERF_PL_GPCR_binding_hAGTR1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in radioligand binding as they relate to gene AGTR1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is angiotensin.", + "assayFunctionType": "radioligand binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "saralasin", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor ", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "angiotensin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2589, + "assayComponentName": "ERF_PL_GPCR_binding_hAGTR1", + "assayComponentDesc": "ERF_PL_GPCR_binding_hAGTR1 is an assay component calculated from the ERF_PL_GPCR_binding_hAGTR1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, angiotensin II, are indicative of changes in receptor function and kinetics related to the gene AGTR1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "angiotensin II", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 744, + "assayName": "ERF_PL_GPCR_hAGTR1", + "assayDesc": "ERF_PL_GPCR_hAGTR1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 3 hour after chemical dosing in a 96-well plate. See AT1 Human Angiotensin GPCR Binding (Agonist Radioligand) Assay, Panlabs.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO-K1 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 19, + "geneName": "angiotensin II receptor, type 1", + "description": null, + "geneSymbol": "AGTR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 185, + "officialSymbol": "AGTR1", + "officialFullName": "angiotensin II receptor, type 1", + "uniprotAccessionNumber": "P30556" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2637, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_hAGTR2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_hAGTR2 was analyzed at the assay endpoint, ERF_PL_GPCR_binding_hAGTR2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in radioligand binding as they relate to gene AGTR2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is angiotensin.", + "assayFunctionType": "radioligand binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "saralasin", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor ", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "angiotensin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2590, + "assayComponentName": "ERF_PL_GPCR_binding_hAGTR2", + "assayComponentDesc": "ERF_PL_GPCR_binding_hAGTR2 is an assay component calculated from the ERF_PL_GPCR_binding_hAGTR2 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [125I] CGP-42112A, are indicative of changes in receptor function and kinetics related to the gene AGTR2.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I] CGP-42112A", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 745, + "assayName": "ERF_PL_GPCR_hAGTR2", + "assayDesc": "ERF_PL_GPCR_hAGTR2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 3 hour after chemical dosing in a 96-well plate. See AT2 Human Angiotensin GPCR Binding (Agonist Radioligand) Assay, Panlabs.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO-K1 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 1620, + "geneName": "angiotensin II receptor type 2", + "description": null, + "geneSymbol": "AGTR2", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 186, + "officialSymbol": "AGTR2", + "officialFullName": "angiotensin II receptor type 2", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2638, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hAVPR1A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hAVPR1A was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hAVPR1A, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene AVPR1A. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is vasopressin and oxytocin.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "[d(CH2)51,Tyr(Me)2]-AVP", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "vasopressin and oxytocin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2591, + "assayComponentName": "ERF_CR_GPCR_binding_hAVPR1A", + "assayComponentDesc": "ERF_CR_GPCR_binding_hAVPR1A is an assay component calculated from the ERF_CR_GPCR_binding_hAVPR1A assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]AVP, are indicative of changes in receptor function and kinetics related to the gene AVPR1A.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]AVP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 714, + "assayName": "ERF_CR_GPCR_hAVPR1A", + "assayDesc": "ERF_CR_GPCR_hAVPR1A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See V1A Human Vasopressin / Oxytocin GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 29, + "geneName": "arginine vasopressin receptor 1A", + "description": null, + "geneSymbol": "AVPR1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 552, + "officialSymbol": "AVPR1A", + "officialFullName": "arginine vasopressin receptor 1A", + "uniprotAccessionNumber": "P37288" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2639, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hBDKRB2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hBDKRB2 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hBDKRB2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene BDKRB2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is bradykinin.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Npc 567", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "bradykinin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2592, + "assayComponentName": "ERF_CR_GPCR_binding_hBDKRB2", + "assayComponentDesc": "ERF_CR_GPCR_binding_hBDKRB2 is an assay component calculated from the ERF_CR_GPCR_binding_hBDKRB2 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Bradykinin, are indicative of changes in receptor function and kinetics related to the gene BDKRB2.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Bradykinin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 795, + "assayName": "ERF_CR_GPCR_hBDKRB2", + "assayDesc": "ERF_CR_GPCR_hBDKRB2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See B2 Human Bradykinin GPCR Binding (Agonist Radioligand) Assay, Cerep - ITEM 33.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 1955, + "geneName": "bradykinin receptor B2", + "description": null, + "geneSymbol": "BDKRB2", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 624, + "officialSymbol": "BDKRB2", + "officialFullName": "bradykinin receptor B2", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2640, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_hCCKAR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_hCCKAR was analyzed at the assay endpoint, ERF_PL_GPCR_binding_hCCKAR, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene CCKAR. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is cholecystokinin.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "devazepide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "cholecystokinin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2593, + "assayComponentName": "ERF_PL_GPCR_binding_hCCKAR", + "assayComponentDesc": "ERF_PL_GPCR_binding_hCCKAR is an assay component calculated from the ERF_PL_GPCR_binding_hCCKAR assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H] L-364,718, are indicative of changes in receptor function and kinetics related to the gene CCKAR.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H] L-364,718", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 748, + "assayName": "ERF_PL_GPCR_hCCKAR", + "assayDesc": "ERF_PL_GPCR_hCCKAR is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See CCK1 (CCKA) Human Cholecystokinin GPCR Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant astrocytoma cells", + "cellShortName": "1321-N1", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 2158, + "geneName": "cholecystokinin A receptor", + "description": null, + "geneSymbol": "CCKAR", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 886, + "officialSymbol": "CCKAR", + "officialFullName": "cholecystokinin A receptor", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2641, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hCCKBR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hCCKBR was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hCCKBR, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene CCKBR. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is cholecystokinin.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "CCK-8s", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "cholecystokinin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2594, + "assayComponentName": "ERF_CR_GPCR_binding_hCCKBR", + "assayComponentDesc": "ERF_CR_GPCR_binding_hCCKBR is an assay component calculated from the ERF_CR_GPCR_binding_hCCKBR assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [125I]CCK-8s, are indicative of changes in receptor function and kinetics related to the gene CCKBR.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]CCK-8s", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 814, + "assayName": "ERF_CR_GPCR_hCCKBR", + "assayDesc": "ERF_CR_GPCR_hCCKBR is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See CCK2 (CCKB) Human Cholecystokinin GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 2159, + "geneName": "cholecystokinin B receptor", + "description": null, + "geneSymbol": "CCKBR", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 887, + "officialSymbol": "CCKBR", + "officialFullName": "cholecystokinin B receptor", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2642, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hCHRM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hCHRM1 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hCHRM1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene CHRM1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is acetylcholine (Muscarinic).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "pirenzepine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "acetylcholine (Muscarinic)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2595, + "assayComponentName": "ERF_CR_GPCR_binding_hCHRM1", + "assayComponentDesc": "ERF_CR_GPCR_binding_hCHRM1 is an assay component calculated from the ERF_CR_GPCR_binding_hCHRM1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]pirenzepine, are indicative of changes in receptor function and kinetics related to the gene CHRM1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]pirenzepine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 835, + "assayName": "ERF_CR_GPCR_hCHRM1", + "assayDesc": "ERF_CR_GPCR_hCHRM1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See M1 Human Acetylcholine (Muscarinic) GPCR Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 61, + "geneName": "cholinergic receptor, muscarinic 1", + "description": null, + "geneSymbol": "CHRM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1128, + "officialSymbol": "CHRM1", + "officialFullName": "cholinergic receptor, muscarinic 1", + "uniprotAccessionNumber": "P11229" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2643, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hCHRM2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hCHRM2 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hCHRM2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene CHRM2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is acetylcholine (Muscarinic).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "methoctramine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "acetylcholine (Muscarinic)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2596, + "assayComponentName": "ERF_CR_GPCR_binding_hCHRM2", + "assayComponentDesc": "ERF_CR_GPCR_binding_hCHRM2 is an assay component calculated from the ERF_CR_GPCR_binding_hCHRM2 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]AF-DX 384, are indicative of changes in receptor function and kinetics related to the gene CHRM2.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]AF-DX 384", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 836, + "assayName": "ERF_CR_GPCR_hCHRM2", + "assayDesc": "ERF_CR_GPCR_hCHRM2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See M2 Human Acetylcholine (Muscarinic) GPCR Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 62, + "geneName": "cholinergic receptor, muscarinic 2", + "description": null, + "geneSymbol": "CHRM2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1129, + "officialSymbol": "CHRM2", + "officialFullName": "cholinergic receptor, muscarinic 2", + "uniprotAccessionNumber": "P08172" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2644, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hCHRM3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hCHRM3 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hCHRM3, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene CHRM3. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is acetylcholine (Muscarinic).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4-Damp methiodide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "acetylcholine (Muscarinic)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2597, + "assayComponentName": "ERF_CR_GPCR_binding_hCHRM3", + "assayComponentDesc": "ERF_CR_GPCR_binding_hCHRM3 is an assay component calculated from the ERF_CR_GPCR_binding_hCHRM3 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]4-DAMP, are indicative of changes in receptor function and kinetics related to the gene CHRM3.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]4-DAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 837, + "assayName": "ERF_CR_GPCR_hCHRM3", + "assayDesc": "ERF_CR_GPCR_hCHRM3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See M3 Human Acetylcholine (Muscarinic) GPCR Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 63, + "geneName": "cholinergic receptor, muscarinic 3", + "description": null, + "geneSymbol": "CHRM3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1131, + "officialSymbol": "CHRM3", + "officialFullName": "cholinergic receptor, muscarinic 3", + "uniprotAccessionNumber": "P20309" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2645, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hCHRM4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hCHRM4 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hCHRM4, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene CHRM4. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is acetylcholine (Muscarinic).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4-Damp methiodide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "acetylcholine (Muscarinic)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2598, + "assayComponentName": "ERF_CR_GPCR_binding_hCHRM4", + "assayComponentDesc": "ERF_CR_GPCR_binding_hCHRM4 is an assay component calculated from the ERF_CR_GPCR_binding_hCHRM4 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]4-DAMP, are indicative of changes in receptor function and kinetics related to the gene CHRM4.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]4-DAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 838, + "assayName": "ERF_CR_GPCR_hCHRM4", + "assayDesc": "ERF_CR_GPCR_hCHRM4 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See M4 Human Acetylcholine (Muscarinic) GPCR Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 64, + "geneName": "cholinergic receptor, muscarinic 4", + "description": null, + "geneSymbol": "CHRM4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1132, + "officialSymbol": "CHRM4", + "officialFullName": "cholinergic receptor, muscarinic 4", + "uniprotAccessionNumber": "P08173" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2646, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hCHRM5", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hCHRM5 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hCHRM5, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene CHRM5. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is acetylcholine (Muscarinic).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4-Damp methiodide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "acetylcholine (Muscarinic)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2599, + "assayComponentName": "ERF_CR_GPCR_binding_hCHRM5", + "assayComponentDesc": "ERF_CR_GPCR_binding_hCHRM5 is an assay component calculated from the ERF_CR_GPCR_binding_hCHRM5 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]4-DAMP, are indicative of changes in receptor function and kinetics related to the gene CHRM5.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]4-DAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 839, + "assayName": "ERF_CR_GPCR_hCHRM5", + "assayDesc": "ERF_CR_GPCR_hCHRM5 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See M5 Human Acetylcholine (Muscarinic) GPCR Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 65, + "geneName": "cholinergic receptor, muscarinic 5", + "description": null, + "geneSymbol": "CHRM5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1133, + "officialSymbol": "CHRM5", + "officialFullName": "cholinergic receptor, muscarinic 5", + "uniprotAccessionNumber": "P08912" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2647, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hCYSLTR1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hCYSLTR1 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hCYSLTR1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene CYSLTR1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is leukotriene.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "leukotriene D4", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "leukotriene", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2600, + "assayComponentName": "ERF_CR_GPCR_binding_hCYSLTR1", + "assayComponentDesc": "ERF_CR_GPCR_binding_hCYSLTR1 is an assay component calculated from the ERF_CR_GPCR_binding_hCYSLTR1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]LTD4, are indicative of changes in receptor function and kinetics related to the gene CYSLTR1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]LTD4", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 833, + "assayName": "ERF_CR_GPCR_hCYSLTR1", + "assayDesc": "ERF_CR_GPCR_hCYSLTR1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See CysLT1 Human Leukotriene GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 9689, + "geneName": "cysteinyl leukotriene receptor 1", + "description": null, + "geneSymbol": "CYSLTR1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 10800, + "officialSymbol": "CYSLTR1", + "officialFullName": "cysteinyl leukotriene receptor 1", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2648, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hDRD1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hDRD1 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hDRD1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene DRD1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is dopamine.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "SCH 23390", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "dopamine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2601, + "assayComponentName": "ERF_CR_GPCR_binding_hDRD1", + "assayComponentDesc": "ERF_CR_GPCR_binding_hDRD1 is an assay component calculated from the ERF_CR_GPCR_binding_hDRD1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-SCH 23390, are indicative of changes in receptor function and kinetics related to the gene DRD1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-SCH 23390", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 819, + "assayName": "ERF_CR_GPCR_hDRD1", + "assayDesc": "ERF_CR_GPCR_hDRD1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See D1 Human Dopamine GPCR Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 99, + "geneName": "dopamine receptor D1", + "description": null, + "geneSymbol": "DRD1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1812, + "officialSymbol": "DRD1", + "officialFullName": "dopamine receptor D1", + "uniprotAccessionNumber": "P21728" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2649, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hDRD2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hDRD2 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hDRD2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene DRD2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is dopamine.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "butaclamol", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "dopamine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2602, + "assayComponentName": "ERF_CR_GPCR_binding_hDRD2", + "assayComponentDesc": "ERF_CR_GPCR_binding_hDRD2 is an assay component calculated from the ERF_CR_GPCR_binding_hDRD2 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]methyl-spiperone, are indicative of changes in receptor function and kinetics related to the gene DRD2.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]methyl-spiperone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 708, + "assayName": "ERF_CR_GPCR_hDRD2", + "assayDesc": "ERF_CR_GPCR_hDRD2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See D2L Human Dopamine GPCR Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant HEK-293 cells", + "cellShortName": "HEK293", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 100, + "geneName": "dopamine receptor D2", + "description": null, + "geneSymbol": "DRD2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1813, + "officialSymbol": "DRD2", + "officialFullName": "dopamine receptor D2", + "uniprotAccessionNumber": "P14416" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2650, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_hDRD4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_hDRD4 was analyzed at the assay endpoint, ERF_PL_GPCR_binding_hDRD4, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene DRD4. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is dopamine.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "spiperone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "dopamine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2603, + "assayComponentName": "ERF_PL_GPCR_binding_hDRD4", + "assayComponentDesc": "ERF_PL_GPCR_binding_hDRD4 is an assay component calculated from the ERF_PL_GPCR_binding_hDRD4 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H] Spiperone, are indicative of changes in receptor function and kinetics related to the gene DRD4.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H] Spiperone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 749, + "assayName": "ERF_PL_GPCR_hDRD4", + "assayDesc": "ERF_PL_GPCR_hDRD4 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See D4.2 Human Dopamine GPCR Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO-K1 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 101, + "geneName": "dopamine receptor D4", + "description": null, + "geneSymbol": "DRD4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1815, + "officialSymbol": "DRD4", + "officialFullName": "dopamine receptor D4", + "uniprotAccessionNumber": "P21917" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2651, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hGALR1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hGALR1 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hGALR1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene GALR1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is galanin.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "galanin", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "galanin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2604, + "assayComponentName": "ERF_CR_GPCR_binding_hGALR1", + "assayComponentDesc": "ERF_CR_GPCR_binding_hGALR1 is an assay component calculated from the ERF_CR_GPCR_binding_hGALR1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [125I]-Galanin, are indicative of changes in receptor function and kinetics related to the gene GALR1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Galanin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 826, + "assayName": "ERF_CR_GPCR_hGALR1", + "assayDesc": "ERF_CR_GPCR_hGALR1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See GAL1 Human Galanin GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 3457, + "geneName": "galanin receptor 1", + "description": null, + "geneSymbol": "GALR1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 2587, + "officialSymbol": "GALR1", + "officialFullName": "galanin receptor 1", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2652, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hHRH1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hHRH1 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hHRH1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene HRH1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is histamine.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "pyrilamine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "histamine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2605, + "assayComponentName": "ERF_CR_GPCR_binding_hHRH1", + "assayComponentDesc": "ERF_CR_GPCR_binding_hHRH1 is an assay component calculated from the ERF_CR_GPCR_binding_hHRH1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Pyrilamine, are indicative of changes in receptor function and kinetics related to the gene HRH1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Pyrilamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 834, + "assayName": "ERF_CR_GPCR_hHRH1", + "assayDesc": "ERF_CR_GPCR_hHRH1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See H1 Human Histamine GPCR Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 160, + "geneName": "histamine receptor H1", + "description": null, + "geneSymbol": "HRH1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3269, + "officialSymbol": "HRH1", + "officialFullName": "histamine receptor H1", + "uniprotAccessionNumber": "P35367" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2653, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hHTR1A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hHTR1A was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hHTR1A, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene HTR1A. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is serotonin.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "8-OH-DPAT", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "serotonin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2606, + "assayComponentName": "ERF_CR_GPCR_binding_hHTR1A", + "assayComponentDesc": "ERF_CR_GPCR_binding_hHTR1A is an assay component calculated from the ERF_CR_GPCR_binding_hHTR1A assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]8-OH-DPAT, are indicative of changes in receptor function and kinetics related to the gene HTR1A.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]8-OH-DPAT", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 700, + "assayName": "ERF_CR_GPCR_hHTR1A", + "assayDesc": "ERF_CR_GPCR_hHTR1A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See 5-HT1A Human Serotonin GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 4067, + "geneName": "5-hydroxytryptamine receptor 1A", + "description": null, + "geneSymbol": "HTR1A", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 3350, + "officialSymbol": "HTR1A", + "officialFullName": "5-hydroxytryptamine receptor 1A", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2654, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hHTR5A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hHTR5A was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hHTR5A, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene HTR5A. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is serotonin.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "serotonin", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "serotonin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2607, + "assayComponentName": "ERF_CR_GPCR_binding_hHTR5A", + "assayComponentDesc": "ERF_CR_GPCR_binding_hHTR5A is an assay component calculated from the ERF_CR_GPCR_binding_hHTR5A assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-lysergic acid diethylamide (LSD), are indicative of changes in receptor function and kinetics related to the gene HTR5A.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-lysergic acid diethylamide (LSD)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 707, + "assayName": "ERF_CR_GPCR_hHTR5A", + "assayDesc": "ERF_CR_GPCR_hHTR5A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See 5-HT5A Human Serotonin GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 167, + "geneName": "5-hydroxytryptamine (serotonin) receptor 5A, G protein-coupled", + "description": null, + "geneSymbol": "HTR5A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3361, + "officialSymbol": "HTR5A", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 5A, G protein-coupled", + "uniprotAccessionNumber": "P47898" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2655, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hHTR6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hHTR6 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hHTR6, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene HTR6. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is serotonin.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "serotonin", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "serotonin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2608, + "assayComponentName": "ERF_CR_GPCR_binding_hHTR6", + "assayComponentDesc": "ERF_CR_GPCR_binding_hHTR6 is an assay component calculated from the ERF_CR_GPCR_binding_hHTR6 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-lysergic acid diethylamide (LSD), are indicative of changes in receptor function and kinetics related to the gene HTR6.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-lysergic acid diethylamide (LSD)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 709, + "assayName": "ERF_CR_GPCR_hHTR6", + "assayDesc": "ERF_CR_GPCR_hHTR6 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See 5-HT6 Human Serotonin GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 168, + "geneName": "5-hydroxytryptamine (serotonin) receptor 6, G protein-coupled", + "description": null, + "geneSymbol": "HTR6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3362, + "officialSymbol": "HTR6", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 6, G protein-coupled", + "uniprotAccessionNumber": "P50406" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2656, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hHTR7", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hHTR7 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hHTR7, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene HTR7. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is serotonin.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "serotonin", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "serotonin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2609, + "assayComponentName": "ERF_CR_GPCR_binding_hHTR7", + "assayComponentDesc": "ERF_CR_GPCR_binding_hHTR7 is an assay component calculated from the ERF_CR_GPCR_binding_hHTR7 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-lysergic acid diethylamide (LSD), are indicative of changes in receptor function and kinetics related to the gene HTR7.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-lysergic acid diethylamide (LSD)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 710, + "assayName": "ERF_CR_GPCR_hHTR7", + "assayDesc": "ERF_CR_GPCR_hHTR7 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See 5-HT7 Human Serotonin GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 169, + "geneName": "5-hydroxytryptamine (serotonin) receptor 7, adenylate cyclase-coupled", + "description": null, + "geneSymbol": "HTR7", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3363, + "officialSymbol": "HTR7", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 7, adenylate cyclase-coupled", + "uniprotAccessionNumber": "P34969" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2657, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_hLTB4R", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_hLTB4R was analyzed at the assay endpoint, ERF_PL_GPCR_binding_hLTB4R, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene LTB4R. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is leukotriene.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "LTB4", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "leukotriene", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2610, + "assayComponentName": "ERF_PL_GPCR_binding_hLTB4R", + "assayComponentDesc": "ERF_PL_GPCR_binding_hLTB4R is an assay component calculated from the ERF_PL_GPCR_binding_hLTB4R assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Leukotriene B4, are indicative of changes in receptor function and kinetics related to the gene LTB4R.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Leukotriene B4", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 757, + "assayName": "ERF_PL_GPCR_hLTB4R", + "assayDesc": "ERF_PL_GPCR_hLTB4R is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See BLT1 (LTB4) Human Leukotriene GPCR Binding (Agonist Radioligand) Assay, Panlabs.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human histiocytic lymphoma U-937 cells", + "cellShortName": "U-937", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 68, + "geneName": "leukotriene B4 receptor", + "description": null, + "geneSymbol": "LTB4R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1241, + "officialSymbol": "LTB4R", + "officialFullName": "leukotriene B4 receptor", + "uniprotAccessionNumber": "Q15722" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2658, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hNPY1R", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hNPY1R was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hNPY1R, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene NPY1R. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is neuropeptide Y.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NPY", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "neuropeptide Y", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2611, + "assayComponentName": "ERF_CR_GPCR_binding_hNPY1R", + "assayComponentDesc": "ERF_CR_GPCR_binding_hNPY1R is an assay component calculated from the ERF_CR_GPCR_binding_hNPY1R assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [125I]-Peptide YY, are indicative of changes in receptor function and kinetics related to the gene NPY1R.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Peptide YY", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 693, + "assayName": "ERF_CR_GPCR_hNPY1R", + "assayDesc": "ERF_CR_GPCR_hNPY1R is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See Y1 Human Neuropeptide Y GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 219, + "geneName": "neuropeptide Y receptor Y1", + "description": null, + "geneSymbol": "NPY1R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4886, + "officialSymbol": "NPY1R", + "officialFullName": "neuropeptide Y receptor Y1", + "uniprotAccessionNumber": "P25929" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2659, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hNPY2R", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hNPY2R was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hNPY2R, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene NPY2R. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is neuropeptide Y.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NPY", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "neuropeptide Y", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2612, + "assayComponentName": "ERF_CR_GPCR_binding_hNPY2R", + "assayComponentDesc": "ERF_CR_GPCR_binding_hNPY2R is an assay component calculated from the ERF_CR_GPCR_binding_hNPY2R assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [125I]-Peptide YY, are indicative of changes in receptor function and kinetics related to the gene NPY2R.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Peptide YY", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 694, + "assayName": "ERF_CR_GPCR_hNPY2R", + "assayDesc": "ERF_CR_GPCR_hNPY2R is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See Y2 Human Neuropeptide Y GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 220, + "geneName": "neuropeptide Y receptor Y2", + "description": null, + "geneSymbol": "NPY2R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4887, + "officialSymbol": "NPY2R", + "officialFullName": "neuropeptide Y receptor Y2", + "uniprotAccessionNumber": "P49146" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2660, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hNTSR1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hNTSR1 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hNTSR1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene NTSR1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is neurotensin.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "neurotensin", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "neurotensin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2613, + "assayComponentName": "ERF_CR_GPCR_binding_hNTSR1", + "assayComponentDesc": "ERF_CR_GPCR_binding_hNTSR1 is an assay component calculated from the ERF_CR_GPCR_binding_hNTSR1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [125I]Tyr3-neurotensin, are indicative of changes in receptor function and kinetics related to the gene NTSR1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]Tyr3-neurotensin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 695, + "assayName": "ERF_CR_GPCR_hNTSR1", + "assayDesc": "ERF_CR_GPCR_hNTSR1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See NT1 Human Neurotensin GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 223, + "geneName": "neurotensin receptor 1 (high affinity)", + "description": null, + "geneSymbol": "NTSR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4923, + "officialSymbol": "NTSR1", + "officialFullName": "neurotensin receptor 1 (high affinity)", + "uniprotAccessionNumber": "P30989" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2661, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hOPRD1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hOPRD1 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hOPRD1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene OPRD1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is opioid.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "DPDPE", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "opioid", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2614, + "assayComponentName": "ERF_CR_GPCR_binding_hOPRD1", + "assayComponentDesc": "ERF_CR_GPCR_binding_hOPRD1 is an assay component calculated from the ERF_CR_GPCR_binding_hOPRD1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]DADLE, are indicative of changes in receptor function and kinetics related to the gene OPRD1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]DADLE", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 696, + "assayName": "ERF_CR_GPCR_hOPRD1", + "assayDesc": "ERF_CR_GPCR_hOPRD1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See delta (DOP) Human Opioid GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 225, + "geneName": "opioid receptor, delta 1", + "description": null, + "geneSymbol": "OPRD1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4985, + "officialSymbol": "OPRD1", + "officialFullName": "opioid receptor, delta 1", + "uniprotAccessionNumber": "P41143" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2662, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hOPRL1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hOPRL1 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hOPRL1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene OPRL1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is opioid.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "nociceptin", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "opioid", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2615, + "assayComponentName": "ERF_CR_GPCR_binding_hOPRL1", + "assayComponentDesc": "ERF_CR_GPCR_binding_hOPRL1 is an assay component calculated from the ERF_CR_GPCR_binding_hOPRL1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]nociceptin, are indicative of changes in receptor function and kinetics related to the gene OPRL1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]nociceptin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 803, + "assayName": "ERF_CR_GPCR_hOPRL1", + "assayDesc": "ERF_CR_GPCR_hOPRL1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See NOP (ORL1) Human Opioid GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 226, + "geneName": "opiate receptor-like 1", + "description": null, + "geneSymbol": "OPRL1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4987, + "officialSymbol": "OPRL1", + "officialFullName": "opiate receptor-like 1", + "uniprotAccessionNumber": "P41146" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2663, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hOPRM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hOPRM1 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hOPRM1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene OPRM1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is opioid.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "DAMGO", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "opioid", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2616, + "assayComponentName": "ERF_CR_GPCR_binding_hOPRM1", + "assayComponentDesc": "ERF_CR_GPCR_binding_hOPRM1 is an assay component calculated from the ERF_CR_GPCR_binding_hOPRM1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]DAMGO, are indicative of changes in receptor function and kinetics related to the gene OPRM1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]DAMGO", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 697, + "assayName": "ERF_CR_GPCR_hOPRM1", + "assayDesc": "ERF_CR_GPCR_hOPRM1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See mu (MOP) Human Opioid GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 227, + "geneName": "opioid receptor, mu 1", + "description": null, + "geneSymbol": "OPRM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4988, + "officialSymbol": "OPRM1", + "officialFullName": "opioid receptor, mu 1", + "uniprotAccessionNumber": "P35372" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2664, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hOXTR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hOXTR was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hOXTR, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene OXTR. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is vasopressin and oxytocin.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "oxytocin", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "vasopressin and oxytocin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2617, + "assayComponentName": "ERF_CR_GPCR_binding_hOXTR", + "assayComponentDesc": "ERF_CR_GPCR_binding_hOXTR is an assay component calculated from the ERF_CR_GPCR_binding_hOXTR assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Oxytocin, are indicative of changes in receptor function and kinetics related to the gene OXTR.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Oxytocin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 807, + "assayName": "ERF_CR_GPCR_hOXTR", + "assayDesc": "ERF_CR_GPCR_hOXTR is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See OT Human Vasopressin / Oxytocin GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant Chem-1 RBL cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 5269, + "geneName": "oxytocin receptor", + "description": null, + "geneSymbol": "OXTR", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5021, + "officialSymbol": "OXTR", + "officialFullName": "oxytocin receptor", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2665, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_hTACR1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_hTACR1 was analyzed at the assay endpoint, ERF_PL_GPCR_binding_hTACR1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in radioligand binding as they relate to gene TACR1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is tachykinin.", + "assayFunctionType": "radioligand binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "L-703606", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "tachykinin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2618, + "assayComponentName": "ERF_PL_GPCR_binding_hTACR1", + "assayComponentDesc": "ERF_PL_GPCR_binding_hTACR1 is an assay component calculated from the ERF_PL_GPCR_binding_hTACR1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Substance P, are indicative of changes in receptor function and kinetics related to the gene TACR1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Substance P", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 759, + "assayName": "ERF_PL_GPCR_hTACR1", + "assayDesc": "ERF_PL_GPCR_hTACR1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.5 hour after chemical dosing in a 96-well plate. See NK1 Human Tachykinin GPCR Binding (Agonist Radioligand) Assay, Panlabs.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 6719, + "geneName": "tachykinin receptor 1", + "description": null, + "geneSymbol": "TACR1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 6869, + "officialSymbol": "TACR1", + "officialFullName": "tachykinin receptor 1", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2666, + "assayComponentEndpointName": "ERF_PL_GPCR_binding_hTACR2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_GPCR_binding_hTACR2 was analyzed at the assay endpoint, ERF_PL_GPCR_binding_hTACR2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in radioligand binding as they relate to gene TACR2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is tachykinin.", + "assayFunctionType": "radioligand binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "MEN-10376", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "tachykinin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2619, + "assayComponentName": "ERF_PL_GPCR_binding_hTACR2", + "assayComponentDesc": "ERF_PL_GPCR_binding_hTACR2 is an assay component calculated from the ERF_PL_GPCR_binding_hTACR2 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H] SR-48968, are indicative of changes in receptor function and kinetics related to the gene TACR2.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H] SR-48968", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 760, + "assayName": "ERF_PL_GPCR_hTACR2", + "assayDesc": "ERF_PL_GPCR_hTACR2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.5 hour after chemical dosing in a 96-well plate. See NK2 Human Tachykinin GPCR Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 309, + "geneName": "tachykinin receptor 2", + "description": null, + "geneSymbol": "TACR2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6865, + "officialSymbol": "TACR2", + "officialFullName": "tachykinin receptor 2", + "uniprotAccessionNumber": "P21452" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2667, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_hVIPR1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_hVIPR1 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_hVIPR1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene VIPR1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is VIP and PACAP.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "VIP ", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "VIP and PACAP", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2620, + "assayComponentName": "ERF_CR_GPCR_binding_hVIPR1", + "assayComponentDesc": "ERF_CR_GPCR_binding_hVIPR1 is an assay component calculated from the ERF_CR_GPCR_binding_hVIPR1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [125I]-Vasoactive intestinal peptide (VIP), are indicative of changes in receptor function and kinetics related to the gene VIPR1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Vasoactive intestinal peptide (VIP)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 713, + "assayName": "ERF_CR_GPCR_hVIPR1", + "assayDesc": "ERF_CR_GPCR_hVIPR1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See VIP1 (VPAC1) Human VIP and PACAP GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 7188, + "geneName": "vasoactive intestinal peptide receptor 1", + "description": null, + "geneSymbol": "VIPR1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 7433, + "officialSymbol": "VIPR1", + "officialFullName": "vasoactive intestinal peptide receptor 1", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2668, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_rGHB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_rGHB was analyzed at the assay endpoint, ERF_CR_GPCR_binding_rGHB, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene TSPAN17. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is ghb .", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NCS382", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "ghb ", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2621, + "assayComponentName": "ERF_CR_GPCR_binding_rGHB", + "assayComponentDesc": "ERF_CR_GPCR_binding_rGHB is an assay component calculated from the ERF_CR_GPCR_binding_rGHB assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-NCS-382, are indicative of changes in receptor function and kinetics related to the gene TSPAN17.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-NCS-382", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 806, + "assayName": "ERF_CR_GPCR_rGHB", + "assayDesc": "ERF_CR_GPCR_rGHB is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See GHB Rat Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "rat cerebral cortex", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 454, + "geneName": "tetraspanin 17", + "description": null, + "geneSymbol": "Tspan17", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 306771, + "officialSymbol": "Tspan17", + "officialFullName": "tetraspanin 17", + "uniprotAccessionNumber": "Q4V8E0" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2669, + "assayComponentEndpointName": "ERF_CR_GPCR_binding_rPY2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_GPCR_binding_rPY2 was analyzed at the assay endpoint, ERF_CR_GPCR_binding_rPY2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene P2RY1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is P2Y.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "datpalphas", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "P2Y", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2622, + "assayComponentName": "ERF_CR_GPCR_binding_rPY2", + "assayComponentDesc": "ERF_CR_GPCR_binding_rPY2 is an assay component calculated from the ERF_CR_GPCR_binding_rPY2 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [35S]dATPalpha S, are indicative of changes in receptor function and kinetics related to the gene P2RY1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[35S]dATPalpha S", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 699, + "assayName": "ERF_CR_GPCR_rPY2", + "assayDesc": "ERF_CR_GPCR_rPY2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See Non-Selective Rat P2Y GPCR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "cell-free", + "cellFreeComponentSource": "rat brain", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 220, + "geneName": "neuropeptide Y receptor Y2", + "description": null, + "geneSymbol": "NPY2R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4887, + "officialSymbol": "NPY2R", + "officialFullName": "neuropeptide Y receptor Y2", + "uniprotAccessionNumber": "P49146" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2670, + "assayComponentEndpointName": "ERF_CR_IC_binding_rCACNA1C_Dihydropyridine", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_IC_binding_rCACNA1C_Dihydropyridine was analyzed at the assay endpoint, ERF_CR_IC_binding_rCACNA1C_Dihydropyridine, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene CACNA1C. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is voltage gated (Calcium).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "nitrendipine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "voltage gated (Calcium)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2623, + "assayComponentName": "ERF_CR_IC_binding_rCACNA1C_Dihydropyridine", + "assayComponentDesc": "ERF_CR_IC_binding_rCACNA1C_Dihydropyridine is an assay component calculated from the ERF_CR_IC_binding_rCACNA1C_Dihydropyridine assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Nitrendipine, are indicative of changes in transporter function and kinetics related to the gene CACNA1C.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Nitrendipine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 715, + "assayName": "ERF_CR_IC_rCACNA1C_Dihydropyridine", + "assayDesc": "ERF_CR_IC_rCACNA1C_Dihydropyridine is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.5 hour after chemical dosing in a 96-well plate. See Cav1.2 (L-type) Rat Calcium Ion Channel Binding (Dihydropyridine Site) Assay, Cerep.", + "timepointHr": 1.5, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 407, + "geneName": "calcium channel, voltage-dependent, P/Q type, alpha 1A subunit", + "description": null, + "geneSymbol": "Cacna1a", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25398, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P54282" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2671, + "assayComponentEndpointName": "ERF_CR_IC_binding_rCACNA1C_Diltiazem", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_IC_binding_rCACNA1C_Diltiazem was analyzed at the assay endpoint, ERF_CR_IC_binding_rCACNA1C_Diltiazem, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene CACNA1C. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is voltage gated (Calcium).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "diltiazem", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "voltage gated (Calcium)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2624, + "assayComponentName": "ERF_CR_IC_binding_rCACNA1C_Diltiazem", + "assayComponentDesc": "ERF_CR_IC_binding_rCACNA1C_Diltiazem is an assay component calculated from the ERF_CR_IC_binding_rCACNA1C_Diltiazem assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Diltiazem, are indicative of changes in transporter function and kinetics related to the gene CACNA1C.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Diltiazem", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 716, + "assayName": "ERF_CR_IC_rCACNA1C_Diltiazem", + "assayDesc": "ERF_CR_IC_rCACNA1C_Diltiazem is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See Cav1.2 (L-type) Rat Calcium Ion Channel Binding (Diltiazem Site) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 407, + "geneName": "calcium channel, voltage-dependent, P/Q type, alpha 1A subunit", + "description": null, + "geneSymbol": "Cacna1a", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25398, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P54282" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2672, + "assayComponentEndpointName": "ERF_CR_IC_binding_rKCNJ1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_IC_binding_rKCNJ1 was analyzed at the assay endpoint, ERF_CR_IC_binding_rKCNJ1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene KCNJ1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is voltage gated (Potassium).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "glyburide potassium salt", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "voltage gated (Potassium)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2625, + "assayComponentName": "ERF_CR_IC_binding_rKCNJ1", + "assayComponentDesc": "ERF_CR_IC_binding_rKCNJ1 is an assay component calculated from the ERF_CR_IC_binding_rKCNJ1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Glibenclamide, are indicative of changes in transporter function and kinetics related to the gene KCNJ1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Glibenclamide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 717, + "assayName": "ERF_CR_IC_rKCNJ1", + "assayDesc": "ERF_CR_IC_rKCNJ1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See KATP Rat Potassium Ion Channel Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 391, + "geneName": "potassium inwardly-rectifying channel, subfamily J, member 1", + "description": null, + "geneSymbol": "Kcnj1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24521, + "officialSymbol": "Kcnj1", + "officialFullName": "potassium inwardly-rectifying channel, subfamily J, member 1", + "uniprotAccessionNumber": "P35560" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2673, + "assayComponentEndpointName": "ERF_CR_IC_binding_rKCNN1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_IC_binding_rKCNN1 was analyzed at the assay endpoint, ERF_CR_IC_binding_rKCNN1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene Kcnn1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is voltage gated (Potassium).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "apamin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "voltage gated (Potassium)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2626, + "assayComponentName": "ERF_CR_IC_binding_rKCNN1", + "assayComponentDesc": "ERF_CR_IC_binding_rKCNN1 is an assay component calculated from the ERF_CR_IC_binding_rKCNN1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [125I]-Apamin, are indicative of changes in transporter function and kinetics related to the gene Kcnn1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Apamin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 718, + "assayName": "ERF_CR_IC_rKCNN1", + "assayDesc": "ERF_CR_IC_rKCNN1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See SKCa (Non-Selective) Rat Potassium Ion Channel [125I] Apamin Binding Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 428, + "geneName": "potassium intermediate/small conductance calcium-activated channel, subfamily N, member 1", + "description": "provisional", + "geneSymbol": "Kcnn1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 54261, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P70606" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2674, + "assayComponentEndpointName": "ERF_CR_IC_binding_rSCN1A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_IC_binding_rSCN1A was analyzed at the assay endpoint, ERF_CR_IC_binding_rSCN1A, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene SCN1A. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is voltage gated (Sodium).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "veratridine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "voltage gated (Sodium)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2627, + "assayComponentName": "ERF_CR_IC_binding_rSCN1A", + "assayComponentDesc": "ERF_CR_IC_binding_rSCN1A is an assay component calculated from the ERF_CR_IC_binding_rSCN1A assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Batrachotoxin, are indicative of changes in transporter function and kinetics related to the gene SCN1A.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Batrachotoxin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 721, + "assayName": "ERF_CR_IC_rSCN1A", + "assayDesc": "ERF_CR_IC_rSCN1A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See Non-Selective Rat Sodium Ion Channel [3H] Batrachotoxinin Binding (Site 2) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 436, + "geneName": "sodium channel, voltage-gated, type I, alpha subunit", + "description": null, + "geneSymbol": "Scn1a", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 81574, + "officialSymbol": "Scn1a", + "officialFullName": "sodium channel, voltage-gated, type I, alpha subunit", + "uniprotAccessionNumber": "P04774" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2675, + "assayComponentEndpointName": "ERF_CR_LGIC_binding_hGABRA1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_LGIC_binding_hGABRA1 was analyzed at the assay endpoint, ERF_CR_LGIC_binding_hGABRA1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene GABRA1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "muscimol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2628, + "assayComponentName": "ERF_CR_LGIC_binding_hGABRA1", + "assayComponentDesc": "ERF_CR_LGIC_binding_hGABRA1 is an assay component calculated from the ERF_CR_LGIC_binding_hGABRA1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]muscimol, are indicative of changes in transporter function and kinetics related to the gene GABRA1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]muscimol", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 788, + "assayName": "ERF_CR_LGIC_hGABRA1", + "assayDesc": "ERF_CR_LGIC_hGABRA1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See GABAA (alpha1/beta2/gamma2) Human GABAA Ion Channel Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO cells", + "cellShortName": "CHO", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 3427, + "geneName": "gamma-aminobutyric acid type A receptor alpha1 subunit", + "description": null, + "geneSymbol": "GABRA1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 2554, + "officialSymbol": "GABRA1", + "officialFullName": "gamma-aminobutyric acid type A receptor alpha1 subunit", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2676, + "assayComponentEndpointName": "ERF_CR_LGIC_binding_rGLRA1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_LGIC_binding_rGLRA1 was analyzed at the assay endpoint, ERF_CR_LGIC_binding_rGLRA1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene GLRA1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated (glycine).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "strychnine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated (glycine)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2629, + "assayComponentName": "ERF_CR_LGIC_binding_rGLRA1", + "assayComponentDesc": "ERF_CR_LGIC_binding_rGLRA1 is an assay component calculated from the ERF_CR_LGIC_binding_rGLRA1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-strychnine, are indicative of changes in transporter function and kinetics related to the gene GLRA1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-strychnine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 831, + "assayName": "ERF_CR_LGIC_rGLRA1", + "assayDesc": "ERF_CR_LGIC_rGLRA1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See Non-Selective Rat Glycine Ion Channel [3H] Strychnine Binding Assay, Cerep.", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "spinal cord", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "rat spinal cord membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 414, + "geneName": "glycine receptor, alpha 1", + "description": null, + "geneSymbol": "Glra1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25674, + "officialSymbol": "Glra1", + "officialFullName": "glycine receptor, alpha 1", + "uniprotAccessionNumber": "P07727" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2677, + "assayComponentEndpointName": "ERF_CR_LGIC_binding_rGRIA1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_LGIC_binding_rGRIA1 was analyzed at the assay endpoint, ERF_CR_LGIC_binding_rGRIA1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene GRIA1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated (glutamate, Ionotropic).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "L-Glutamate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated (glutamate, Ionotropic)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2630, + "assayComponentName": "ERF_CR_LGIC_binding_rGRIA1", + "assayComponentDesc": "ERF_CR_LGIC_binding_rGRIA1 is an assay component calculated from the ERF_CR_LGIC_binding_rGRIA1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-AMPA, are indicative of changes in transporter function and kinetics related to the gene GRIA1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-AMPA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 827, + "assayName": "ERF_CR_LGIC_rGRIA1", + "assayDesc": "ERF_CR_LGIC_rGRIA1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See Glutamate (AMPA, Non-Selective) Rat Ion Channel [3H] AMPA Binding Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 424, + "geneName": "glutamate receptor, ionotropic, AMPA 1", + "description": null, + "geneSymbol": "Gria1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 50592, + "officialSymbol": "Gria1", + "officialFullName": "glutamate receptor, ionotropic, AMPA 1", + "uniprotAccessionNumber": "P19490" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2678, + "assayComponentEndpointName": "ERF_CR_LGIC_binding_rGRIK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_LGIC_binding_rGRIK1 was analyzed at the assay endpoint, ERF_CR_LGIC_binding_rGRIK1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene GRIK1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated (glutamate, Ionotropic).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "kainic acid", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated (glutamate, Ionotropic)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2631, + "assayComponentName": "ERF_CR_LGIC_binding_rGRIK1", + "assayComponentDesc": "ERF_CR_LGIC_binding_rGRIK1 is an assay component calculated from the ERF_CR_LGIC_binding_rGRIK1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Kainic acid, are indicative of changes in transporter function and kinetics related to the gene GRIK1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Kainic acid", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 830, + "assayName": "ERF_CR_LGIC_rGRIK1", + "assayDesc": "ERF_CR_LGIC_rGRIK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See Glutamate (Kianate, Non-Selective) Rat Ion Channel [3H] Kainic acid Binding Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 420, + "geneName": "glutamate receptor, ionotropic, kainate 1", + "description": null, + "geneSymbol": "Grik1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 29559, + "officialSymbol": "Grik1", + "officialFullName": "glutamate receptor, ionotropic, kainate 1", + "uniprotAccessionNumber": "P22756" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2679, + "assayComponentEndpointName": "ERF_PL_LGIC_binding_rGRIN1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_LGIC_binding_rGRIN1 was analyzed at the assay endpoint, ERF_PL_LGIC_binding_rGRIN1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene GRIN1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated (glutamate, Ionotropic).", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated (glutamate, Ionotropic)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2632, + "assayComponentName": "ERF_PL_LGIC_binding_rGRIN1", + "assayComponentDesc": "ERF_PL_LGIC_binding_rGRIN1 is an assay component calculated from the ERF_PL_LGIC_binding_rGRIN1 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-MK-801, are indicative of changes in transporter function and kinetics related to the gene GRIN1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-MK-801", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 752, + "assayName": "ERF_PL_LGIC_rGRIN1", + "assayDesc": "ERF_PL_LGIC_rGRIN1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See Glutamate (Kainate, Non-Selective) Rat Ion Channel [3H] Kainic acid Binding Assay, Panlabs.", + "timepointHr": 2.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "male Wistar rat cortex membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 387, + "geneName": "glutamate receptor, ionotropic, N-methyl D-aspartate 1", + "description": null, + "geneSymbol": "Grin1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24408, + "officialSymbol": "Grin1", + "officialFullName": "glutamate receptor, ionotropic, N-methyl D-aspartate 1", + "uniprotAccessionNumber": "P35439" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2680, + "assayComponentEndpointName": "ERF_CR_MP_binding_hTSPO", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_MP_binding_hTSPO was analyzed at the assay endpoint, ERF_CR_MP_binding_hTSPO, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene TSPO. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the membrane protein intended target family, where the subfamily is mitochondrial associated translocator protein.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "PK 11195", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "membrane protein", + "intendedTargetFamilySub": "mitochondrial associated translocator protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2633, + "assayComponentName": "ERF_CR_MP_binding_hTSPO", + "assayComponentDesc": "ERF_CR_MP_binding_hTSPO is an assay component calculated from the ERF_CR_MP_hTSPO assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-PK11195, are indicative of changes in receptor function and kinetics related to the gene TSPO.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-PK11195", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 804, + "assayName": "ERF_CR_MP_hTSPO", + "assayDesc": "ERF_CR_MP_hTSPO is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See PBR Human Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human endogenous U-118-MG", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 37, + "geneName": "translocator protein (18kDa)", + "description": null, + "geneSymbol": "TSPO", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 706, + "officialSymbol": "TSPO", + "officialFullName": "translocator protein (18kDa)", + "uniprotAccessionNumber": "P30536" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2681, + "assayComponentEndpointName": "ERF_PL_NR_binding_hAR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_NR_binding_hAR was analyzed at the assay endpoint, ERF_PL_NR_binding_hAR, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in radioligand binding as they relate to gene AR. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is androgens.", + "assayFunctionType": "radioligand binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "testosterone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "androgens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2634, + "assayComponentName": "ERF_PL_NR_binding_hAR", + "assayComponentDesc": "ERF_PL_NR_binding_hAR is an assay component calculated from the ERF_PL_NR_binding_hAR assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-methyltrienolone, are indicative of changes in receptor function and kinetics related to the gene AR.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-methyltrienolone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 742, + "assayName": "ERF_PL_NR_hAR", + "assayDesc": "ERF_PL_NR_hAR is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 20 hour after chemical dosing in a 96-well plate. See AR Human Androgen NHR Binding (Agonist Radioligand) Assay, Panlabs.", + "timepointHr": 20.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human LNCaP clone FGC cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2682, + "assayComponentEndpointName": "ERF_PL_NR_COA_hFXR_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_NR_COA_hFXR_Antagonist was analyzed at the assay endpoint, ERF_PL_NR_COA_hFXR_Antagonist, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene NR1H4. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is liver X receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Z-Guggulsterone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "liver X receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2635, + "assayComponentName": "ERF_PL_NR_COA_hFXR_Antagonist", + "assayComponentDesc": "ERF_PL_NR_COA_hFXR_Antagonist is an assay component calculated from the ERF_PL_NR_COA_hFXR_Antagonist assay. It is designed to measure TR-FRET using a type of binding reporter as detected by fluorescence intensity of 7-hydroxy-coumarin with FRET: TR-FRET technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity of 7-hydroxy-coumarin produced from the receptor binding reaction involving the key ligand;antibody, Fluorescein-labeled coactivator peptide;Terbium-labeled anti-GST antibody, are indicative of changes in receptor function and kinetics related to the gene NR1H4.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "FRET", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "FRET: TR-FRET", + "keyAssayReagentType": "ligand;antibody", + "keyAssayReagent": "Fluorescein-labeled coactivator peptide;Terbium-labeled anti-GST antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 794, + "assayName": "ERF_PL_NR_COA_hFXR_Antagonist", + "assayDesc": "ERF_PL_NR_COA_hFXR_Antagonist is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See FXR Human Liver X Receptor-Like NHR Functional Antagonist Coactivator Assay, Panlabs.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 357, + "geneName": "nuclear receptor subfamily 1, group H, member 4", + "description": null, + "geneSymbol": "NR1H4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9971, + "officialSymbol": "NR1H4", + "officialFullName": "nuclear receptor subfamily 1, group H, member 4", + "uniprotAccessionNumber": "Q96RI1" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2683, + "assayComponentEndpointName": "ERF_CR_NR_binding_hGR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_NR_binding_hGR was analyzed at the assay endpoint, ERF_CR_NR_binding_hGR, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene NR3C1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "triamcinolone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2636, + "assayComponentName": "ERF_CR_NR_binding_hGR", + "assayComponentDesc": "ERF_CR_NR_binding_hGR is an assay component calculated from the ERF_CR_NR_binding_hGR assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-dexamethasone, are indicative of changes in receptor function and kinetics related to the gene NR3C1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-dexamethasone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 822, + "assayName": "ERF_CR_NR_hGR", + "assayDesc": "ERF_CR_NR_hGR is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 6 hour after chemical dosing in a 96-well plate. See GR Human Glucocorticoid NHR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human endogenous IM-9 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2684, + "assayComponentEndpointName": "ERF_PL_NR_binding_hHTR2C", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_NR_binding_hHTR2C was analyzed at the assay endpoint, ERF_PL_NR_binding_hHTR2C, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in radioligand binding as they relate to gene HTR2C. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is serotonin.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "SB 242084", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "serotonin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2637, + "assayComponentName": "ERF_PL_NR_binding_hHTR2C", + "assayComponentDesc": "ERF_PL_NR_binding_hHTR2C is an assay component calculated from the ERF_PL_NR_binding_hHTR2C assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Mesulergine, are indicative of changes in receptor function and kinetics related to the gene HTR2C.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Mesulergine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 763, + "assayName": "ERF_PL_NR_hHTR2C", + "assayDesc": "ERF_PL_NR_hHTR2C is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See 5-HT2C Human Serotonin GPCR Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO-K1 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 165, + "geneName": "5-hydroxytryptamine (serotonin) receptor 2C, G protein-coupled", + "description": null, + "geneSymbol": "HTR2C", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3358, + "officialSymbol": "HTR2C", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 2C, G protein-coupled", + "uniprotAccessionNumber": "P28335" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2685, + "assayComponentEndpointName": "ERF_CR_NR_binding_hPGR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_NR_binding_hPGR was analyzed at the assay endpoint, ERF_CR_NR_binding_hPGR, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene PGR. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "promegestone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2638, + "assayComponentName": "ERF_CR_NR_binding_hPGR", + "assayComponentDesc": "ERF_CR_NR_binding_hPGR is an assay component calculated from the ERF_CR_NR_binding_hPGR assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]progesterone, are indicative of changes in receptor function and kinetics related to the gene PGR.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]progesterone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 754, + "assayName": "ERF_CR_NR_hPGR", + "assayDesc": "ERF_CR_NR_hPGR is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 20 hour after chemical dosing in a 96-well plate. See PR Human Progesterone NHR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 20.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human endogenous T47D cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2686, + "assayComponentEndpointName": "ERF_CR_NR_binding_hPPARA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_NR_binding_hPPARA was analyzed at the assay endpoint, ERF_CR_NR_binding_hPPARA, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene PPARA. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GW 7647", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2639, + "assayComponentName": "ERF_CR_NR_binding_hPPARA", + "assayComponentDesc": "ERF_CR_NR_binding_hPPARA is an assay component calculated from the ERF_CR_NR_binding_hPPARA assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]WY 14643, are indicative of changes in receptor function and kinetics related to the gene PPARA.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]WY 14643", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 828, + "assayName": "ERF_CR_NR_hPPARA", + "assayDesc": "ERF_CR_NR_hPPARA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See PPARalpha Human NHR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 248, + "geneName": "peroxisome proliferator-activated receptor alpha", + "description": null, + "geneSymbol": "PPARA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5465, + "officialSymbol": "PPARA", + "officialFullName": "peroxisome proliferator-activated receptor alpha", + "uniprotAccessionNumber": "Q07869" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2687, + "assayComponentEndpointName": "ERF_CR_NR_binding_hPPARG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_NR_binding_hPPARG was analyzed at the assay endpoint, ERF_CR_NR_binding_hPPARG, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in binding as they relate to gene PPARG. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "rosiglitazone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2640, + "assayComponentName": "ERF_CR_NR_binding_hPPARG", + "assayComponentDesc": "ERF_CR_NR_binding_hPPARG is an assay component calculated from the ERF_CR_NR_binding_hPPARG assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]rosiglitazone, are indicative of changes in receptor function and kinetics related to the gene PPARG.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]rosiglitazone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 829, + "assayName": "ERF_CR_NR_hPPARG", + "assayDesc": "ERF_CR_NR_hPPARG is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See PPARgamma Human NHR Binding (Agonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 250, + "geneName": "peroxisome proliferator-activated receptor gamma", + "description": null, + "geneSymbol": "PPARG", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5468, + "officialSymbol": "PPARG", + "officialFullName": "peroxisome proliferator-activated receptor gamma", + "uniprotAccessionNumber": "P37231" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2688, + "assayComponentEndpointName": "ERF_PL_NR_binding_hRARa", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_NR_binding_hRARa was analyzed at the assay endpoint, ERF_PL_NR_binding_hRARa, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in radioligand binding as they relate to gene RARA. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is retinoic acid receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "9-cis-Retinoic acid", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "retinoic acid receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2641, + "assayComponentName": "ERF_PL_NR_binding_hRARa", + "assayComponentDesc": "ERF_PL_NR_binding_hRARa is an assay component calculated from the ERF_PL_NR_binding_hRARa assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H] 9-cis-Retinoic acid, are indicative of changes in receptor function and kinetics related to the gene RARA.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H] 9-cis-Retinoic acid", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 762, + "assayName": "ERF_PL_NR_hRARa", + "assayDesc": "ERF_PL_NR_hRARa is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See RARalpha Human Retinoic Acid NHR Binding (Agonist Radioligand) Assay, Panlabs.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 279, + "geneName": "retinoic acid receptor, alpha", + "description": null, + "geneSymbol": "RARA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5914, + "officialSymbol": "RARA", + "officialFullName": "retinoic acid receptor, alpha", + "uniprotAccessionNumber": "P10276" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2689, + "assayComponentEndpointName": "ERF_PL_NR_COA_hTHRA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_NR_COA_hTHRA_Agonist was analyzed at the assay endpoint, ERF_PL_NR_COA_hTHRA_Agonist, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of agonist, gain-of-signal activity can be used to understand changes in protein-protein interaction as they relate to gene THRA. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2642, + "assayComponentName": "ERF_PL_NR_COA_hTHRA", + "assayComponentDesc": "ERF_PL_NR_COA_hTHRA is an assay component calculated from the ERF_PL_NR_COA_hTHRA assay. It is designed to measure TR-FRET using a type of inducible reporter as detected by fluorescence intensity of 7-hydroxy-coumarin with FRET: TR-FRET technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity of 7-hydroxy-coumarin produced from the regulation of transcription factor activity reaction involving the key ligand; antibody, liothyronine, are indicative of changes in receptor function and kinetics related to the gene THRA.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "FRET", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "FRET: TR-FRET", + "keyAssayReagentType": "ligand;antibody", + "keyAssayReagent": "liothyronine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 802, + "assayName": "ERF_PL_NR_COA_hTHRA", + "assayDesc": "ERF_PL_NR_COA_hTHRA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See TRalpha Human Thyroid Hormone NHR Functional Agonist Coactivator Assay, Panlabs.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 321, + "geneName": "thyroid hormone receptor, alpha", + "description": null, + "geneSymbol": "THRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7067, + "officialSymbol": "THRA", + "officialFullName": "thyroid hormone receptor, alpha", + "uniprotAccessionNumber": "P10827" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2690, + "assayComponentEndpointName": "ERF_PL_NR_binding_rI2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_NR_binding_rI2 was analyzed at the assay endpoint, ERF_PL_NR_binding_rI2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in radioligand binding as they relate to gene NISCH (homolog). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is imidazoline receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "idazoxan", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "imidazoline receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2643, + "assayComponentName": "ERF_PL_NR_binding_rI2", + "assayComponentDesc": "ERF_PL_NR_binding_rI2 is an assay component calculated from the ERF_PL_NR_binding_rI2 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H] Idazoxan, are indicative of changes in receptor function and kinetics related to the gene NISCH (homolog), gene id 100009085.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H] Idazoxan", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 755, + "assayName": "ERF_PL_NR_rI2", + "assayDesc": "ERF_PL_NR_rI2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See Imidazoline I2, Central Rat Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 0.5, + "organismId": 9986, + "organism": "rabbit", + "tissue": "cerebral cortex", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "male Wistar rat cerebral cortex", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 10019, + "geneName": "nischarin", + "description": null, + "geneSymbol": "NISCH", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 11188, + "officialSymbol": "NISCH", + "officialFullName": "nischarin", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2691, + "assayComponentEndpointName": "ERF_PL_TR_binding_hSLC35B3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_TR_binding_hSLC35B3 was analyzed at the assay endpoint, ERF_PL_TR_binding_hSLC35B3, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in transporter binding as they relate to gene SLC29A1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is nucleoside transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "nitrobenzylthioinosine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "nucleoside transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2644, + "assayComponentName": "ERF_PL_TR_binding_hSLC35B3", + "assayComponentDesc": "ERF_PL_TR_binding_hSLC35B3 is an assay component calculated from the ERF_PL_TR_binding_hSLC35B3 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Nitrobenzylthioinosine, are indicative of changes in transporter function and kinetics related to the gene SLC29A1.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Nitrobenzylthioinosine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 737, + "assayName": "ERF_PL_TR_hSLC35B3", + "assayDesc": "ERF_PL_TR_hSLC35B3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See Adenosine Human Transporter Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human u937 cells CRL-1593", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 112, + "geneName": "solute carrier family 29 (equilibrative nucleoside transporter), member 1", + "description": null, + "geneSymbol": "SLC29A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2030, + "officialSymbol": "SLC29A1", + "officialFullName": "solute carrier family 29 (equilibrative nucleoside transporter), member 1", + "uniprotAccessionNumber": "Q99808" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2692, + "assayComponentEndpointName": "ERF_CR_TR_binding_hSLC6A2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_TR_binding_hSLC6A2 was analyzed at the assay endpoint, ERF_CR_TR_binding_hSLC6A2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene SLC6A2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is SLC6 / Monoamine.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "protriptyline", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "SLC6 / Monoamine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2645, + "assayComponentName": "ERF_CR_TR_binding_hSLC6A2", + "assayComponentDesc": "ERF_CR_TR_binding_hSLC6A2 is an assay component calculated from the ERF_CR_TR_binding_hSLC6A2 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-Nisoxetine, are indicative of changes in transporter function and kinetics related to the gene SLC6A2.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Nisoxetine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 801, + "assayName": "ERF_CR_TR_hSLC6A2", + "assayDesc": "ERF_CR_TR_hSLC6A2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See NET Human Norepinephrine Transporter Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 296, + "geneName": "solute carrier family 6 (neurotransmitter transporter), member 2", + "description": null, + "geneSymbol": "SLC6A2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6530, + "officialSymbol": "SLC6A2", + "officialFullName": "solute carrier family 6 (neurotransmitter transporter), member 2", + "uniprotAccessionNumber": "P23975" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2693, + "assayComponentEndpointName": "ERF_CR_TR_binding_hSLC6A3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_TR_binding_hSLC6A3 was analyzed at the assay endpoint, ERF_CR_TR_binding_hSLC6A3, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in binding as they relate to gene SLC6A3. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is SLC6 / Monoamine.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "BTCP", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "SLC6 / Monoamine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2646, + "assayComponentName": "ERF_CR_TR_binding_hSLC6A3", + "assayComponentDesc": "ERF_CR_TR_binding_hSLC6A3 is an assay component calculated from the ERF_CR_TR_binding_hSLC6A3 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]BTCP, are indicative of changes in transporter function and kinetics related to the gene SLC6A3.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]BTCP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 825, + "assayName": "ERF_CR_TR_hSLC6A3", + "assayDesc": "ERF_CR_TR_hSLC6A3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hour after chemical dosing in a 96-well plate. See DAT Human Dopamine Transporter Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 297, + "geneName": "solute carrier family 6 (neurotransmitter transporter), member 3", + "description": null, + "geneSymbol": "SLC6A3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6531, + "officialSymbol": "SLC6A3", + "officialFullName": "solute carrier family 6 (neurotransmitter transporter), member 3", + "uniprotAccessionNumber": "Q01959" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2694, + "assayComponentEndpointName": "ERF_CR_TR_binding_hSLC6A4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_TR_binding_hSLC6A4 was analyzed at the assay endpoint, ERF_CR_TR_binding_hSLC6A4, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene SLC6A4. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is SLC6 / Monoamine.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "imipramine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "SLC6 / Monoamine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2647, + "assayComponentName": "ERF_CR_TR_binding_hSLC6A4", + "assayComponentDesc": "ERF_CR_TR_binding_hSLC6A4 is an assay component calculated from the ERF_CR_TR_binding_hSLC6A4 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]imipramine, are indicative of changes in transporter function and kinetics related to the gene SLC6A4.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]imipramine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 818, + "assayName": "ERF_CR_TR_hSLC6A4", + "assayDesc": "ERF_CR_TR_hSLC6A4 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See SET Human Serotonin Transporter Binding (Antagonist Radioligand) Assay, Cerep.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant CHO cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 298, + "geneName": "solute carrier family 6 (neurotransmitter transporter), member 4", + "description": null, + "geneSymbol": "SLC6A4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6532, + "officialSymbol": "SLC6A4", + "officialFullName": "solute carrier family 6 (neurotransmitter transporter), member 4", + "uniprotAccessionNumber": "P31645" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2695, + "assayComponentEndpointName": "ERF_PL_TR_binding_rSLC18A2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_TR_binding_rSLC18A2 was analyzed at the assay endpoint, ERF_PL_TR_binding_rSLC18A2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in transporter binding as they relate to gene SLC18A2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is vesicular transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetrabenazine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "vesicular transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2648, + "assayComponentName": "ERF_PL_TR_binding_rSLC18A2", + "assayComponentDesc": "ERF_PL_TR_binding_rSLC18A2 is an assay component calculated from the ERF_PL_TR_binding_rSLC18A2 assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-dihydrotetrabenazine, are indicative of changes in transporter function and kinetics related to the gene SLC18A2.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-dihydrotetrabenazine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 758, + "assayName": "ERF_PL_TR_rSLC18A2", + "assayDesc": "ERF_PL_TR_rSLC18A2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See VMAT2 Rat Vesicular Monoamine Transporter Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 0.5, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "rat brain minus cerebellum", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 408, + "geneName": "solute carrier family 18 (vesicular monoamine transporter), member 2", + "description": null, + "geneSymbol": "Slc18a2", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25549, + "officialSymbol": "Slc18a2", + "officialFullName": "solute carrier family 18 (vesicular monoamine transporter), member 2", + "uniprotAccessionNumber": "Q01827" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2696, + "assayComponentEndpointName": "ERF_PL_TR_binding_rTSPO", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_TR_binding_rTSPO was analyzed at the assay endpoint, ERF_PL_TR_binding_rTSPO, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand changes in transporter binding as they relate to gene TSPO. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is cholesterol transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "diazepam", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "cholesterol transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2649, + "assayComponentName": "ERF_PL_TR_binding_rTSPO", + "assayComponentDesc": "ERF_PL_TR_binding_rTSPO is an assay component calculated from the ERF_PL_TR_binding_rTSPO assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the receptor binding reaction involving the key ligand, [3H]-PK11195, are indicative of changes in transporter function and kinetics related to the gene TSPO.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-PK11195", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 751, + "assayName": "ERF_PL_TR_rTSPO", + "assayDesc": "ERF_PL_TR_rTSPO is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See PBR Rat Binding (Antagonist Radioligand) Assay, Panlabs.", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "heart", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "male Wistar rat heart", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 382, + "geneName": "translocator protein", + "description": null, + "geneSymbol": "Tspo", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24230, + "officialSymbol": "Tspo", + "officialFullName": "translocator protein", + "uniprotAccessionNumber": "P16257" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2697, + "assayComponentEndpointName": "UKN2_HCS_IMR90_neural_migration", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint UKN2_HCS_IMR90_neural_migration was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, gain or loss-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is neural crest cell migration.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Cytochalasin D", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural crest cell migration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2650, + "assayComponentName": "UKN2_HCS_IMR90_neural_migration", + "assayComponentDesc": "UKN2_HCS_IMR90_neural_migration is an assay component measured from the UKN2_HCS_IMR90 assay. It is designed to make measurements of neural crest cell migration, a form of morphology reporter, as detected with Fluorescence intensity signals by HCS Fluorescent Imaging.", + "assayComponentTargetDesc": "Changes in the number of migrated cells are indicative of neurodevelopment.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neural crest cell migration", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain;stain", + "keyAssayReagent": "calcein-AM; Hoechst 33341", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of migrated cells", + "aid": 840, + "assayName": "UKN2_HCS_IMR90", + "assayDesc": "UKN2_HCS_IMR90 is a cell-based, multiplexed-readout assay screening for neural crest cell migration and cell viability that uses IMR90 (neural crest cells differentiated from iPSC), a human embryo cell line, with measurements taken at 3 hours after chemical dosing in a microplate: 96-well plate. UKN2, also known as cMINC, is an assay that uses IMR90 cells (neural crest cells differentiated from iPSC) as a model of neural crest cell migration. 24 hr after cell seeding, cell migration was initiated and proceeded for 24 hr. Then, chemical was applied, and after 24 hr of exposure migration and viability were assessed using high-content imaging of cells stained with calcein-AM and Hoechst H-33342.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "embryo", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "IMR90 (neural crest cells differentiated from iPSC)", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 27, + "assaySourceName": "UKN", + "assaySourceLongName": "University of Konstanz", + "assaySourceDesc": "The Leist research group at the University of Konstanz conducts high content imaging assays for neurotoxicity.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-1977-y", + "url": "https://pubmed.ncbi.nlm.nih.gov/28477266/", + "pmid": 28477266, + "title": "Combination of multiple neural crest migration assays to identify environmental toxicants from a proof-of-concept chemical library", + "author": "Nyffeler J, Dolde X, Krebs A, Pinto-Gil K, Pastor M, Behl M, Waldmann T, Leist M", + "citation": "Nyffeler J, Dolde X, Krebs A, Pinto-Gil K, Pastor M, Behl M, Waldmann T, Leist M. Combination of multiple neural crest migration assays to identify environmental toxicants from a proof-of-concept chemical library. Arch Toxicol. 2017 Nov;91(11):3613-3632. doi: 10.1007/s00204-017-1977-y. Epub 2017 May 5. PMID: 28477266.", + "otherId": "0", + "citationId": 280, + "otherSource": "" + } + }, + { + "aeid": 2699, + "assayComponentEndpointName": "UKN2_HCS_IMR90_cell_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint UKN2_HCS_IMR90_cell_viability was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain or loss-of-signal activity can be used to understand viability effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is viability.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "viability", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2651, + "assayComponentName": "UKN2_HCS_IMR90_cell_viability", + "assayComponentDesc": "UKN2_HCS_IMR90_cell_viability is an assay component measured from the UKN2_HCS_IMR90 assay. It is designed to make measurements of enzyme activity, a form of viability reporter, as detected with Fluorescence intensity signals by HCS Fluorescent Imaging.", + "assayComponentTargetDesc": "Changes in the number of Hoechst labelled nuclei are indicative of viability.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "cytotoxicity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain;stain", + "keyAssayReagent": "calcein-AM; Hoechst 33342", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of Hoechst labelled nuclei", + "aid": 840, + "assayName": "UKN2_HCS_IMR90", + "assayDesc": "UKN2_HCS_IMR90 is a cell-based, multiplexed-readout assay screening for neural crest cell migration and cell viability that uses IMR90 (neural crest cells differentiated from iPSC), a human embryo cell line, with measurements taken at 3 hours after chemical dosing in a microplate: 96-well plate. UKN2, also known as cMINC, is an assay that uses IMR90 cells (neural crest cells differentiated from iPSC) as a model of neural crest cell migration. 24 hr after cell seeding, cell migration was initiated and proceeded for 24 hr. Then, chemical was applied, and after 24 hr of exposure migration and viability were assessed using high-content imaging of cells stained with calcein-AM and Hoechst H-33342.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "embryo", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "IMR90 (neural crest cells differentiated from iPSC)", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 27, + "assaySourceName": "UKN", + "assaySourceLongName": "University of Konstanz", + "assaySourceDesc": "The Leist research group at the University of Konstanz conducts high content imaging assays for neurotoxicity.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-1977-y", + "url": "https://pubmed.ncbi.nlm.nih.gov/28477266/", + "pmid": 28477266, + "title": "Combination of multiple neural crest migration assays to identify environmental toxicants from a proof-of-concept chemical library", + "author": "Nyffeler J, Dolde X, Krebs A, Pinto-Gil K, Pastor M, Behl M, Waldmann T, Leist M", + "citation": "Nyffeler J, Dolde X, Krebs A, Pinto-Gil K, Pastor M, Behl M, Waldmann T, Leist M. Combination of multiple neural crest migration assays to identify environmental toxicants from a proof-of-concept chemical library. Arch Toxicol. 2017 Nov;91(11):3613-3632. doi: 10.1007/s00204-017-1977-y. Epub 2017 May 5. PMID: 28477266.", + "otherId": "0", + "citationId": 280, + "otherSource": "" + } + }, + { + "aeid": 2701, + "assayComponentEndpointName": "UKN4_HCS_LUHMES_neurite_outgrowth", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint UKN4_HCS_LUHMES_neurite_outgrowth was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, gain or loss-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is neurite outgrowth.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Narciclasine", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2652, + "assayComponentName": "UKN4_HCS_LUHMES_neurite_outgrowth", + "assayComponentDesc": "UKN4_HCS_LUHMES_neurite_outgrowth is an assay component measured from the UKN4_HCS_LHUMES assay. It is designed to make measurements of neurite outgrowth, a form of morphology reporter, as detected with Fluorescence intensity signals by HCS Fluorescent Imaging.", + "assayComponentTargetDesc": "Changes in the neurite area are indicative of neurodevelopment.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain;stain", + "keyAssayReagent": "calcein-AM; Hoechst 33343", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "neurite area", + "aid": 841, + "assayName": "UKN4_HCS_LUHMES", + "assayDesc": "UKN4_HCS_LUHMES is a cell-based, multiplexed-readout assay screening for neurite outgrowth and cell viability that uses LUHMES, a human central nervous system cell line, with measurements taken at 3 hours after chemical dosing in a microplate: 96-well plate. UKN4, also referred to as NeuriTox, is an assay that uses LUHMES neuronal precursors as a model of dopaminergic neuronal differentiation. Following a 2-day differentiation period, cells are exposed to chemicals for 24 hr and neurite area is evaluated as a marker of neurite outgrowth using high-content imaging of cells stained with calcein AM. Cell viability is assessed using stain Hoechst H-33342.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "central nervous system", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "LUHMES", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 27, + "assaySourceName": "UKN", + "assaySourceLongName": "University of Konstanz", + "assaySourceDesc": "The Leist research group at the University of Konstanz conducts high content imaging assays for neurotoxicity.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-013-1072-y", + "url": "https://pubmed.ncbi.nlm.nih.gov/23670202/", + "pmid": 23670202, + "title": "Evaluation of a human neurite growth assay as specific screen for developmental neurotoxicants", + "author": "Krug AK, Balmer NV, Matt F, Schönenberger F, Merhof D, Leist M", + "citation": "Krug AK, Balmer NV, Matt F, Schönenberger F, Merhof D, Leist M. Evaluation of a human neurite growth assay as specific screen for developmental neurotoxicants. Arch Toxicol. 2013 Dec;87(12):2215-31. doi: 10.1007/s00204-013-1072-y. Epub 2013 May 14. PMID: 23670202.", + "otherId": "0", + "citationId": 278, + "otherSource": "" + } + }, + { + "aeid": 2703, + "assayComponentEndpointName": "UKN4_HCS_LUHMES_cell_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint UKN4_HCS_LUHMES_cell_viability was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain or loss-of-signal activity can be used to understand viability effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is viability.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "viability", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2653, + "assayComponentName": "UKN4_HCS_LUHMES_cell_viability", + "assayComponentDesc": "UKN4_HCS_LUHMES_cell_viability is an assay component measured from the UKN4_HCS_LHUMES assay. It is designed to make measurements of enzyme activity, a form of viability reporter, as detected with Fluorescence intensity signals by HCS Fluorescent Imaging.", + "assayComponentTargetDesc": "Changes in the number of Hoechst labelled nuclei are indicative of viability.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "cytotoxicity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain;stain", + "keyAssayReagent": "calcein-AM; Hoechst 33344", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of Hoechst labelled nuclei", + "aid": 841, + "assayName": "UKN4_HCS_LUHMES", + "assayDesc": "UKN4_HCS_LUHMES is a cell-based, multiplexed-readout assay screening for neurite outgrowth and cell viability that uses LUHMES, a human central nervous system cell line, with measurements taken at 3 hours after chemical dosing in a microplate: 96-well plate. UKN4, also referred to as NeuriTox, is an assay that uses LUHMES neuronal precursors as a model of dopaminergic neuronal differentiation. Following a 2-day differentiation period, cells are exposed to chemicals for 24 hr and neurite area is evaluated as a marker of neurite outgrowth using high-content imaging of cells stained with calcein AM. Cell viability is assessed using stain Hoechst H-33342.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "central nervous system", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "LUHMES", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 27, + "assaySourceName": "UKN", + "assaySourceLongName": "University of Konstanz", + "assaySourceDesc": "The Leist research group at the University of Konstanz conducts high content imaging assays for neurotoxicity.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-013-1072-y", + "url": "https://pubmed.ncbi.nlm.nih.gov/23670202/", + "pmid": 23670202, + "title": "Evaluation of a human neurite growth assay as specific screen for developmental neurotoxicants", + "author": "Krug AK, Balmer NV, Matt F, Schönenberger F, Merhof D, Leist M", + "citation": "Krug AK, Balmer NV, Matt F, Schönenberger F, Merhof D, Leist M. Evaluation of a human neurite growth assay as specific screen for developmental neurotoxicants. Arch Toxicol. 2013 Dec;87(12):2215-31. doi: 10.1007/s00204-013-1072-y. Epub 2013 May 14. PMID: 23670202.", + "otherId": "0", + "citationId": 278, + "otherSource": "" + } + }, + { + "aeid": 2705, + "assayComponentEndpointName": "ERF_PL_NR_binding_hPPARG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_NR_binding_hPPARG was analyzed at the assay endpoint, ERF_PL_NR_binding_hPPARG, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding receptor, gain-of-signal activity can be used to understand changes in binding receptor as they relate to gene PPARG.To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rosiglitazone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2654, + "assayComponentName": "ERF_PL_NR_binding_hPPARG", + "assayComponentDesc": "ERF_PL_NR_binding_hPPARG is an assay component calculated from the ERF_PL_NR_hPPARG assay. It is designed to measure radioligand binding using a type of binding reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in radiometry produced from the receptor binding reaction involving the ligand [3H] Rosiglitazone are indicative of changes in receptor function and kinetics related to the gene PPARG.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H] Rosiglitazone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 842, + "assayName": "ERF_PL_NR_hPPARG", + "assayDesc": "ERF_PL_NR_hPPARG is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 24 hour after chemical dosing in a 96-well plate. See PPARgamma Human NHR Binding (Agonist Radioligand) Assay, Panlabs.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human full length recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 250, + "geneName": "peroxisome proliferator-activated receptor gamma", + "description": null, + "geneSymbol": "PPARG", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5468, + "officialSymbol": "PPARG", + "officialFullName": "peroxisome proliferator-activated receptor gamma", + "uniprotAccessionNumber": "P37231" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2731, + "assayComponentEndpointName": "TAMU_HCS_1.5hr_SingleDonor1434_Cytotoxicity", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TAMU_HCS_1.5hr_Cytotoxicity was analyzed into 1 assay endpoint. This assay endpoint, TAMU_HCS_1.5hr_Cytotoxicity, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in the viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2667, + "assayComponentName": "TAMU_HCS_1.5hr_SingleDonor1434_Cytotoxicity", + "assayComponentDesc": "TAMU_HCS_1.5hr_SingleDonor1434_Cytotoxicity is a phenotype derived from the Total.Cells parameter and uses an EC10 as its POD (10% decrease in total cell count, compared to controls). Total Cells measures the total number of nuclei (cell count) using HCS Fluorescent Imaging technology. There is no preprocessing performed on the data to model this phenotype.", + "assayComponentTargetDesc": "Changes in the total number of nuclei (cell count) is used to quantify changes in cell number, which can be an indication of cell death.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell number", + "biologicalProcessTarget": "cytotoxicity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst-33342 dye; MitoTracker Orange; Ca+2 dye", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "nucleus", + "aid": 843, + "assayName": "TAMU_HCS_1.5hr", + "assayDesc": "TAMU_HCS_1.5hr is a cell-based, multiplexed-readout assay that uses iPSC-derived cardiomyocytes with measurements taken at 1.5 hours after chemical dosing in a microplate: 384-well plate.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "heart", + "cellFormat": "cell-based", + "cellFreeComponentSource": "iPSC-derived cardiomyocytes", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 29, + "assaySourceName": "TAMU", + "assaySourceLongName": "Texas A&M University", + "assaySourceDesc": null, + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.1c00203", + "url": "https://pubmed.ncbi.nlm.nih.gov/34448577/", + "pmid": 34448577, + "title": "Cardiotoxicity Hazard and Risk Characterization of ToxCast Chemicals Using Human Induced Pluripotent Stem Cell-Derived Cardiomyocytes from Multiple Donors", + "author": "Burnett SD, Blanchette AD, Chiu WA, Rusyn I", + "citation": "Burnett SD, Blanchette AD, Chiu WA, Rusyn I. Cardiotoxicity Hazard and Risk Characterization of ToxCast Chemicals Using Human Induced Pluripotent Stem Cell-Derived Cardiomyocytes from Multiple Donors. Chem Res Toxicol. 2021 Aug 27. doi: 10.1021/acs.chemrestox.1c00203. Epub ahead of print. PMID: 34448577.", + "otherId": "0", + "citationId": 286, + "otherSource": "" + } + }, + { + "aeid": 2760, + "assayComponentEndpointName": "TAMU_PeakParms_SingleDonor1434_QT", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TAMU_PeakParms_SingleDonor1434_QT was analyzed into 1 assay endpoints. This assay endpoint, TAMU_PeakParms_SingleDonor1434_QT_Prolongation, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain-of-signal activity can be used to understand changes in the cardiac function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cardiomyocyte function intended target family, where the subfamily is QT interval.", + "assayFunctionType": "cardiac function", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential ", + "intendedTargetFamily": "cardiomyocyte function", + "intendedTargetFamilySub": "QT interval", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2682, + "assayComponentName": "TAMU_PeakParms_SingleDonor1434_QT", + "assayComponentDesc": "TAMU_PeakParms_SingleDonor1434_QT is a phenotype derived from the decay.rise.ratio.avg parameter and uses an EC05 as its POD (5% increase in decay/rise ratio, compared to controls). Decay.Rise.Ratio.Average measures as the average ratio between the rise time and the decay time of the calcium flux, using Fluorescence intensity as a functional reporter from Calcium (Ca+2) flux assay technology. Before modeling, data is preprocessed to remove data points where there is a cessation of beating (where peak.freq.avg equals 0) and data points after they develop of a severe notch phenotype in order to avoid capturing non monotonic effects related to an advanced pathology.", + "assayComponentTargetDesc": "Changes in the calcium flux readouts is used to quantify changes in the QT interval, which can be an indication of an increased QT interval, a significant risk factor for severe arrhythmia. ", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "QT interval", + "biologicalProcessTarget": "cardiac function", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Calcium (Ca+2) flux assay", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Ca+2 dye reagent", + "technologicalTargetType": "calcium influx rate", + "technologicalTargetTypeSub": "average ratio between the rise time and the decay time of the calcium flux", + "aid": 845, + "assayName": "TAMU_PeakParms", + "assayDesc": "TAMU_PeakParms is a cell-based, multiplexed-readout assay that uses iPSC-derived cardiomyocytes with measurements taken at 1.5 hours after chemical dosing in a microplate: 384-well plate.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "heart", + "cellFormat": "cell-based", + "cellFreeComponentSource": "iPSC-derived cardiomyocytes", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 29, + "assaySourceName": "TAMU", + "assaySourceLongName": "Texas A&M University", + "assaySourceDesc": null, + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.1c00203", + "url": "https://pubmed.ncbi.nlm.nih.gov/34448577/", + "pmid": 34448577, + "title": "Cardiotoxicity Hazard and Risk Characterization of ToxCast Chemicals Using Human Induced Pluripotent Stem Cell-Derived Cardiomyocytes from Multiple Donors", + "author": "Burnett SD, Blanchette AD, Chiu WA, Rusyn I", + "citation": "Burnett SD, Blanchette AD, Chiu WA, Rusyn I. Cardiotoxicity Hazard and Risk Characterization of ToxCast Chemicals Using Human Induced Pluripotent Stem Cell-Derived Cardiomyocytes from Multiple Donors. Chem Res Toxicol. 2021 Aug 27. doi: 10.1021/acs.chemrestox.1c00203. Epub ahead of print. PMID: 34448577.", + "otherId": "0", + "citationId": 286, + "otherSource": "" + } + }, + { + "aeid": 2767, + "assayComponentEndpointName": "TAMU_PeakParms_SingleDonor1434_Chronotropy", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TAMU_PeakParms_SingleDonor1434_Chronotropy was analyzed into 1 assay endpoint. This assay endpoint, TAMU_PeakParms_SingleDonor1434_Chronotropy_Negative, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand changes in the cardiac function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cardiomyocyte function intended target family, where the subfamily is lowered beat rate.", + "assayFunctionType": "cardiac function", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential ", + "intendedTargetFamily": "cardiomyocyte function", + "intendedTargetFamilySub": "lowered beat rate", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2685, + "assayComponentName": "TAMU_PeakParms_SingleDonor1434_Chronotropy", + "assayComponentDesc": "TAMU_PeakParms_SingleDonor1434_Chronotopy is a phenotype derived from the peak.freq.avg parameter and uses an EC05 as its POD (5% increase in beat rate, compared to controls). Peak.Freq.Avg measures the average peak frequency, in beats per second, uisng Fluorescence intensity as a functional reporter from Calcium (Ca+2) flux assay technology. Before modeling, data is preprocessed to remove data points where there is a cessation of beating (where peak.freq.avg equals 0) to ensure the capture of the upwards response that isn't confounded by the drop in beat rate at higher concentrations and to ensure the drop in beat rate is captured before asystole, which is captured elsewhere.", + "assayComponentTargetDesc": "Changes in the calcium flux readouts is used to quantify changes in peak frequency, which can be an indication of elevated or lowered beat rate.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "beating", + "biologicalProcessTarget": "cardiac function", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Calcium (Ca+2) flux assay", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Ca+2 dye reagent", + "technologicalTargetType": "calcium influx rate", + "technologicalTargetTypeSub": "average peak frequency, in beats per second", + "aid": 845, + "assayName": "TAMU_PeakParms", + "assayDesc": "TAMU_PeakParms is a cell-based, multiplexed-readout assay that uses iPSC-derived cardiomyocytes with measurements taken at 1.5 hours after chemical dosing in a microplate: 384-well plate.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "heart", + "cellFormat": "cell-based", + "cellFreeComponentSource": "iPSC-derived cardiomyocytes", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 29, + "assaySourceName": "TAMU", + "assaySourceLongName": "Texas A&M University", + "assaySourceDesc": null, + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.1c00203", + "url": "https://pubmed.ncbi.nlm.nih.gov/34448577/", + "pmid": 34448577, + "title": "Cardiotoxicity Hazard and Risk Characterization of ToxCast Chemicals Using Human Induced Pluripotent Stem Cell-Derived Cardiomyocytes from Multiple Donors", + "author": "Burnett SD, Blanchette AD, Chiu WA, Rusyn I", + "citation": "Burnett SD, Blanchette AD, Chiu WA, Rusyn I. Cardiotoxicity Hazard and Risk Characterization of ToxCast Chemicals Using Human Induced Pluripotent Stem Cell-Derived Cardiomyocytes from Multiple Donors. Chem Res Toxicol. 2021 Aug 27. doi: 10.1021/acs.chemrestox.1c00203. Epub ahead of print. PMID: 34448577.", + "otherId": "0", + "citationId": 286, + "otherSource": "" + } + }, + { + "aeid": 2771, + "assayComponentEndpointName": "IUF_NPC1b_proliferation_BrdU_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC1b_proliferation_BrdU component was analyzed at the endpoint IUF_NPC1b_proliferation_BrdU in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of growth reporter, gain or loss-of-signal activity can be used to understand cell proliferation effects.", + "assayFunctionType": "cell proliferation", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "media without growth factors", + "signalDirection": "bidirectional", + "intendedTargetType": "dna", + "intendedTargetTypeSub": "dna-unspecified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2687, + "assayComponentName": "IUF_NPC1b_proliferation_BrdU_72hr", + "assayComponentDesc": "IUF_NPC1b_proliferation_BrdU_72hr is one of 4 assay components measured from the IUF_NPC1 assay. It is designed to measure cell proliferation as assessed by the incorporation of Bromodeoxyuridine (BrdU) in the last 16 h of a 72 h compound exposure using a luminescence-based cell proliferation ELISA.", + "assayComponentTargetDesc": "Changes to chemiluminescence signals based on BrdU incorporation during DNA synthesis in proliferating cells are correlated to proliferation of the system.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "growth reporter", + "assayDesignTypeSub": "dna content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Chemiluminescence", + "detectionTechnologyTypeSub": "luminescence intensity", + "detectionTechnology": "Luminescence-based cell proliferation ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "BrdU antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "BrdU labeled DNA", + "aid": 846, + "assayName": "IUF_NPC1", + "assayDesc": "IUF_NPC1 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. Grown in suspension culture and under proliferative conditions (proliferation media and growth factors), these cells represent neural progenitor cell proliferation. In the NPC1 assay, hNPC's are exposed to the test compound for 72h. Cell proliferation is assessed as an increase in sphere area using automated phase contrast imaging and as incorporation of Bromodeoxyuridine (BrdU) during DNA synthesis using a luminescence-based cell proliferation ELISA. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2773, + "assayComponentEndpointName": "IUF_NPC1a_proliferation_area_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC1a_proliferation_area component was analyzed at the endpoint IUF_NPC1a_proliferation_area in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of growth reporter, gain or loss-of-signal activity can be used to understand cell proliferation effects.", + "assayFunctionType": "cell proliferation", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "media without growth factors", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "sphere size", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2688, + "assayComponentName": "IUF_NPC1a_proliferation_area_72hr", + "assayComponentDesc": "IUF_NPC1a_proliferation_area_72hr is one of 4 assay components measured from the IUF_NPC1 assay. It is designed to measure cell proliferation as assessed by an increase in sphere area over 72 h using automated phase contrast imaging.", + "assayComponentTargetDesc": "Changes in sphere size based on microscopic measurements are correlated to the proliferation of the system. ", + "parameterReadoutType": "multiplexed", + "assayDesignType": "growth reporter", + "assayDesignTypeSub": "real-time cell-growth kinetics", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Increases in sphere area", + "detectionTechnology": "Automated phase contrast imaging ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "sphere size", + "aid": 846, + "assayName": "IUF_NPC1", + "assayDesc": "IUF_NPC1 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. Grown in suspension culture and under proliferative conditions (proliferation media and growth factors), these cells represent neural progenitor cell proliferation. In the NPC1 assay, hNPC's are exposed to the test compound for 72h. Cell proliferation is assessed as an increase in sphere area using automated phase contrast imaging and as incorporation of Bromodeoxyuridine (BrdU) during DNA synthesis using a luminescence-based cell proliferation ELISA. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2775, + "assayComponentEndpointName": "IUF_NPC1_viability_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC1_viability component was analyzed at the endpoint IUF_NPC1_viability in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain or loss-of-signal activity can be used to understand viability effects.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "lysed cells", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "viability", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2689, + "assayComponentName": "IUF_NPC1_viability_72hr", + "assayComponentDesc": "IUF_NPC1_viability_72hr is one of 4 assay components measured from the IUF_NPC1 assay. It is designed to measure cell viability assessed as mitochondria-dependent reduction of resazurin to resorufin using the alamar blue cell viability assay. Viability is measured as a fluorescence signal (relative fluorescence unit) in a multiplate reader. ", + "assayComponentTargetDesc": "Changes in mitochondrial activity are correlated to cellular viability.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "cell viability", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Alamar blue viability assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "resazurin", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 846, + "assayName": "IUF_NPC1", + "assayDesc": "IUF_NPC1 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. Grown in suspension culture and under proliferative conditions (proliferation media and growth factors), these cells represent neural progenitor cell proliferation. In the NPC1 assay, hNPC's are exposed to the test compound for 72h. Cell proliferation is assessed as an increase in sphere area using automated phase contrast imaging and as incorporation of Bromodeoxyuridine (BrdU) during DNA synthesis using a luminescence-based cell proliferation ELISA. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2776, + "assayComponentEndpointName": "ERF_PL_NR_COA_hFXR_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_NR_COA_hFXR_Agonist was analyzed at the assay endpoint, ERF_PL_NR_COA_hFXR_Agonist, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene NR1H4. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is liver X receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "CDCA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2690, + "assayComponentName": "ERF_PL_NR_COA_binding_hFXR_Agonist", + "assayComponentDesc": "ERF_PL_NR_COA_hFXR_Agonist is an assay component calculated from the ERF_PL_NR_COA_hFXR_Agonist assay. It is designed to measure TR-FRET using a type of binding reporter as detected by fluorescence intensity with FRET: TR-FRET technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the receptor binding reaction involving the key ligand;antibody, Fluorescein-labeled coactivator peptide;Terbium-labeled anti-GST antibody, are indicative of changes in receptor function and kinetics related to the gene NR1H4.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "FRET", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "FRET: TR-FRET", + "keyAssayReagentType": "ligand;antibody", + "keyAssayReagent": "Fluorescein-labeled coactivator peptide; Terbium-labeled anti-GST antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 847, + "assayName": "ERF_PL_NR_COA_hFXR_Agonist", + "assayDesc": "ERF_PL_NR_COA_hFXR_Agonist is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate. See FXR Human Liver X Receptor-Like NHR Functional Agonist Coactivator Assay, Panlabs.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 357, + "geneName": "nuclear receptor subfamily 1, group H, member 4", + "description": null, + "geneSymbol": "NR1H4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9971, + "officialSymbol": "NR1H4", + "officialFullName": "nuclear receptor subfamily 1, group H, member 4", + "uniprotAccessionNumber": "Q96RI1" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2777, + "assayComponentEndpointName": "CCTE_Mundy_HCI_Cortical_NOG_BPCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_Cortical_NOG_BPCount was analyzed at the endpoint CCTE_Mundy_HCI_Cortical_NOG_BPCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2699, + "assayComponentName": "CCTE_Mundy_HCI_Cortical_NOG_BPCount", + "assayComponentDesc": "CCTE_Mundy_HCI_Cortical_NOG_BPCount is one of four components of the CCTE_Mundy_HCI_Cortical_NOG assay. It measures neurite outgrowth related to the number of branch points using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of branch points are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of branch points", + "aid": 850, + "assayName": "CCTE_Mundy_HCI_Cortical_NOG", + "assayDesc": "CCTE_Mundy_HCI_Cortical_NOG is a multiplexed, cell-based-readout assay that uses rat primary cortical cells with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "rat primary cortical cells", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2778, + "assayComponentEndpointName": "CCTE_Mundy_HCI_Cortical_NOG_NeuriteCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_Cortical_NOG_NeuriteCount was analyzed at the endpoint CCTE_Mundy_HCI_Cortical_NOG_NeuriteCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2698, + "assayComponentName": "CCTE_Mundy_HCI_Cortical_NOG_NeuriteCount", + "assayComponentDesc": "CCTE_Mundy_HCI_Cortical_NOG_NeuriteCount is one of four components of the CCTE_Mundy_HCI_Cortical_NOG assay. It measures neurite outgrowth related to the number of neurites using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of neurites are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of neurites", + "aid": 850, + "assayName": "CCTE_Mundy_HCI_Cortical_NOG", + "assayDesc": "CCTE_Mundy_HCI_Cortical_NOG is a multiplexed, cell-based-readout assay that uses rat primary cortical cells with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "rat primary cortical cells", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2779, + "assayComponentEndpointName": "CCTE_Mundy_HCI_Cortical_NOG_NeuriteLength", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_Cortical_NOG_NeuriteLength was analyzed at the endpoint CCTE_Mundy_HCI_Cortical_NOG_NeuriteLength in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2697, + "assayComponentName": "CCTE_Mundy_HCI_Cortical_NOG_NeuriteLength", + "assayComponentDesc": "CCTE_Mundy_HCI_Cortical_NOG_NeuriteLength is one of four components of the CCTE_Mundy_HCI_Cortical_NOG assay. It measures neurite outgrowth related to the neurite length using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the neurite length are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "neurite length", + "aid": 850, + "assayName": "CCTE_Mundy_HCI_Cortical_NOG", + "assayDesc": "CCTE_Mundy_HCI_Cortical_NOG is a multiplexed, cell-based-readout assay that uses rat primary cortical cells with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "rat primary cortical cells", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2780, + "assayComponentEndpointName": "CCTE_Mundy_HCI_Cortical_NOG_NeuronCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_Cortical_NOG_NeuronCount was analyzed at the endpoint CCTE_Mundy_HCI_Cortical_NOG_NeuronCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2696, + "assayComponentName": "CCTE_Mundy_HCI_Cortical_NOG_NeuronCount", + "assayComponentDesc": "CCTE_Mundy_HCI_Cortical_NOG_NeuronCount is one of four components of the CCTE_Mundy_HCI_Cortical_NOG assay. It measures cell viability related to the number of neurons using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of neurons are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of neurons", + "aid": 850, + "assayName": "CCTE_Mundy_HCI_Cortical_NOG", + "assayDesc": "CCTE_Mundy_HCI_Cortical_NOG is a multiplexed, cell-based-readout assay that uses rat primary cortical cells with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "rat primary cortical cells", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2781, + "assayComponentEndpointName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_BPCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_BPCount was analyzed at the endpoint CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_BPCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "sodium orthovanadate (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "synaptogenesis and neurite maturation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2707, + "assayComponentName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_BPCount", + "assayComponentDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_BPCount is one of eight components of the CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur assay. It measures synaptogenesis and neurite maturation related to number of branch points using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of branch points are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "synaptogenesis and neurite maturation", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MAP2 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of branch points", + "aid": 852, + "assayName": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur", + "assayDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur is a multiplexed, cell-based-readout assay that uses rat primary cortical cells with measurements taken at 288.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 288.33, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "rat primary cortical cells", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2782, + "assayComponentEndpointName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_CellBodySpotCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_CellBodySpotCount was analyzed at the endpoint CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_CellBodySpotCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "sodium orthovanadate (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "synaptogenesis and neurite maturation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2702, + "assayComponentName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_CellBodySpotCount", + "assayComponentDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_CellBodySpotCount is one of eight components of the CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur assay. It measures synaptogenesis and neurite maturation related to number of cell body-associated synapses (synaptophysin puncta) per neuron using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of cell body-associated synapses (synaptophysin puncta) per neuron are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "synaptogenesis and neurite maturation", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Synaptophysin antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of cell body-associated synapses (synaptophysin puncta) per neuron", + "aid": 852, + "assayName": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur", + "assayDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur is a multiplexed, cell-based-readout assay that uses rat primary cortical cells with measurements taken at 288.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 288.33, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "rat primary cortical cells", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2783, + "assayComponentEndpointName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteCount was analyzed at the endpoint CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "sodium orthovanadate (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "synaptogenesis and neurite maturation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2706, + "assayComponentName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteCount", + "assayComponentDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteCount is one of eight components of the CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur assay. It measures synaptogenesis and neurite maturation related to number of neurites using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of neurites are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "synaptogenesis and neurite maturation", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MAP2 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of neurites", + "aid": 852, + "assayName": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur", + "assayDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur is a multiplexed, cell-based-readout assay that uses rat primary cortical cells with measurements taken at 288.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 288.33, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "rat primary cortical cells", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2784, + "assayComponentEndpointName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteLength", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteLength was analyzed at the endpoint CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteLength in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "sodium orthovanadate (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "synaptogenesis and neurite maturation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2705, + "assayComponentName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteLength", + "assayComponentDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteLength is one of eight components of the CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur assay. It measures synaptogenesis and neurite maturation related to neurite length using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the neurite length are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "synaptogenesis and neurite maturation", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MAP2 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "neurite length", + "aid": 852, + "assayName": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur", + "assayDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur is a multiplexed, cell-based-readout assay that uses rat primary cortical cells with measurements taken at 288.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 288.33, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "rat primary cortical cells", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2785, + "assayComponentEndpointName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteSpotCountPerNeuriteLength", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteSpotCountPerNeuriteLength was analyzed at the endpoint CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteSpotCountPerNeuriteLength in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "sodium orthovanadate (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "synaptogenesis and neurite maturation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2704, + "assayComponentName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteSpotCountPerNeuriteLength", + "assayComponentDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteSpotCountPerNeuriteLength is one of eight components of the CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur assay. It measures synaptogenesis and neurite maturation related to number of neurite-associated synapses (synaptophysin puncta) per unit length of neurite using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of neurite-associated synapses (synaptophysin puncta) per unit length of neurite are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "synaptogenesis and neurite maturation", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Synaptophysin antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of neurite-associated synapses (synaptophysin puncta) per unit length of neurite", + "aid": 852, + "assayName": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur", + "assayDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur is a multiplexed, cell-based-readout assay that uses rat primary cortical cells with measurements taken at 288.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 288.33, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "rat primary cortical cells", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2786, + "assayComponentEndpointName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteSpotCountPerNeuron", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteSpotCountPerNeuron was analyzed at the endpoint CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteSpotCountPerNeuron in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "sodium orthovanadate (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "synaptogenesis and neurite maturation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2703, + "assayComponentName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteSpotCountPerNeuron", + "assayComponentDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuriteSpotCountPerNeuron is one of eight components of the CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur assay. It measures synaptogenesis and neurite maturation related to number of neurite-associated synapses (synaptophysin puncta) per neuron using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of neurite-associated synapses (synaptophysin puncta) per neuron are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "synaptogenesis and neurite maturation", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Synaptophysin antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of neurite-associated synapses (synaptophysin puncta) per neuron", + "aid": 852, + "assayName": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur", + "assayDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur is a multiplexed, cell-based-readout assay that uses rat primary cortical cells with measurements taken at 288.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 288.33, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "rat primary cortical cells", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2787, + "assayComponentEndpointName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuronCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuronCount was analyzed at the endpoint CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuronCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "sodium orthovanadate (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "synaptogenesis and neurite maturation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2701, + "assayComponentName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuronCount", + "assayComponentDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_NeuronCount is one of eight components of the CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur assay. It measures cell viability related to number of neurons using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of neurons are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MAP2 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of neurons", + "aid": 852, + "assayName": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur", + "assayDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur is a multiplexed, cell-based-readout assay that uses rat primary cortical cells with measurements taken at 288.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 288.33, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "rat primary cortical cells", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2788, + "assayComponentEndpointName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_SynapseCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_SynapseCount was analyzed at the endpoint CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_SynapseCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "sodium orthovanadate (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "synaptogenesis and neurite maturation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2708, + "assayComponentName": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_SynapseCount", + "assayComponentDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neur_Matur_SynapseCount is one of eight components of the CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur assay. It measures synaptogenesis and neurite maturation related to number of synpases per neuron using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of synpases per neuron are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "synaptogenesis and neurite maturation", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Synaptophysin antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of synpases per neuron", + "aid": 852, + "assayName": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur", + "assayDesc": "CCTE_Mundy_HCI_Cortical_Synap&Neurite_Matur is a multiplexed, cell-based-readout assay that uses rat primary cortical cells with measurements taken at 288.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 288.33, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "rat primary cortical cells", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2789, + "assayComponentEndpointName": "CCTE_Mundy_HCI_hN2_NOG_BPCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_hN2_NOG_BPCount was analyzed at the endpoint CCTE_Mundy_HCI_hN2_NOG_BPCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects. This assay component endpoint is considered less reliable by experts on the assay due to low occurrence of branch points in the hN2 cells. Use data with caution.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2695, + "assayComponentName": "CCTE_Mundy_HCI_hN2_NOG_BPCount", + "assayComponentDesc": "CCTE_Mundy_HCI_hN2_NOG_BPCount is one of four components of the CCTE_Mundy_HCI_hN2_NOG assay. It measures neurite outgrowth related to number of branch points using High Content Imaging of fluorescently labelled markers. This assay component is considered less reliable by experts on the assay due to low occurrence of branch points in the hN2 cells. Use data with caution.", + "assayComponentTargetDesc": "Changes in the number of branch points are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of branch points", + "aid": 849, + "assayName": "CCTE_Mundy_HCI_hN2_NOG", + "assayDesc": "CCTE_Mundy_HCI_hN2_NOG is a multiplexed, cell-based-readout assay that uses immature neurons derived from hNP1 neuroprogenitor cells with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "secondary cell", + "cellFreeComponentSource": "immature neurons derived from hNP1 neuroprogenitor cells", + "cellShortName": "hN2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2790, + "assayComponentEndpointName": "CCTE_Mundy_HCI_hN2_NOG_NeuriteCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_hN2_NOG_NeuriteCount was analyzed at the endpoint CCTE_Mundy_HCI_hN2_NOG_NeuriteCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2694, + "assayComponentName": "CCTE_Mundy_HCI_hN2_NOG_NeuriteCount", + "assayComponentDesc": "CCTE_Mundy_HCI_hN2_NOG_NeuriteCount is one of four components of the CCTE_Mundy_HCI_hN2_NOG assay. It measures neurite outgrowth related to number of neurites using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of neurites are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of neurites", + "aid": 849, + "assayName": "CCTE_Mundy_HCI_hN2_NOG", + "assayDesc": "CCTE_Mundy_HCI_hN2_NOG is a multiplexed, cell-based-readout assay that uses immature neurons derived from hNP1 neuroprogenitor cells with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "secondary cell", + "cellFreeComponentSource": "immature neurons derived from hNP1 neuroprogenitor cells", + "cellShortName": "hN2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2791, + "assayComponentEndpointName": "CCTE_Mundy_HCI_hN2_NOG_NeuriteLength", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_hN2_NOG_NeuriteLength was analyzed at the endpoint CCTE_Mundy_HCI_hN2_NOG_NeuriteLength in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2693, + "assayComponentName": "CCTE_Mundy_HCI_hN2_NOG_NeuriteLength", + "assayComponentDesc": "CCTE_Mundy_HCI_hN2_NOG_NeuriteLength is one of four components of the CCTE_Mundy_HCI_hN2_NOG assay. It measures neurite outgrowth related to neurite length using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the neurite length are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "neurite length", + "aid": 849, + "assayName": "CCTE_Mundy_HCI_hN2_NOG", + "assayDesc": "CCTE_Mundy_HCI_hN2_NOG is a multiplexed, cell-based-readout assay that uses immature neurons derived from hNP1 neuroprogenitor cells with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "secondary cell", + "cellFreeComponentSource": "immature neurons derived from hNP1 neuroprogenitor cells", + "cellShortName": "hN2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2792, + "assayComponentEndpointName": "CCTE_Mundy_HCI_hN2_NOG_NeuronCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_hN2_NOG_NeuronCount was analyzed at the endpoint CCTE_Mundy_HCI_hN2_NOG_NeuronCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss -of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2692, + "assayComponentName": "CCTE_Mundy_HCI_hN2_NOG_NeuronCount", + "assayComponentDesc": "CCTE_Mundy_HCI_hN2_NOG_NeuronCount is one of four components of the CCTE_Mundy_HCI_hN2_NOG assay. It measures cell viability related to number of neurons using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of neurons are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of neurons", + "aid": 849, + "assayName": "CCTE_Mundy_HCI_hN2_NOG", + "assayDesc": "CCTE_Mundy_HCI_hN2_NOG is a multiplexed, cell-based-readout assay that uses immature neurons derived from hNP1 neuroprogenitor cells with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "secondary cell", + "cellFreeComponentSource": "immature neurons derived from hNP1 neuroprogenitor cells", + "cellShortName": "hN2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2793, + "assayComponentEndpointName": "CCTE_Mundy_HCI_hNP1_Casp3_7", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_hNP1_Casp3_7 was analyzed at the endpoint CCTE_Mundy_HCI_hNP1_Casp3_7_gain in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain -of-signal activity can be used to understand viability effects.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine (0.1 uM)", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "apoptosis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2691, + "assayComponentName": "CCTE_Mundy_HCI_hNP1_Casp3_7", + "assayComponentDesc": "CCTE_Mundy_HCI_hNP1_Casp3_7 is one component of the CCTE_Mundy_HCI_hNP1_Casp3_7 assay. It measures apoptosis related to caspase activation using Luminescent Reporter.", + "assayComponentTargetDesc": "Changes in the caspase activation are indicative of cell death.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "apoptosis", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "Luminescent Reporter", + "keyAssayReagentType": "luciferase assay", + "keyAssayReagent": "Caspase-Glo 3/7 detection reagent", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "caspase activation", + "aid": 848, + "assayName": "CCTE_Mundy_HCI_hNP1_Casp3_7", + "assayDesc": "CCTE_Mundy_HCI_hNP1_Casp3_7 is a multiplexed, cell-based-readout assay that uses neural stem cells derived from a neuroepithelial cell lineage of WA09 embryonic cells with measurements taken at 26.5 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 26.5, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural stem cells derived from a neuroepithelial cell lineage of WA09 embryonic cells", + "cellShortName": "hNP1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2794, + "assayComponentEndpointName": "CCTE_Mundy_HCI_hNP1_CellTiter", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_hNP1_CellTiter was analyzed at the endpoint CCTE_Mundy_HCI_hNP1_CellTiter in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss -of-signal activity can be used to understand viability effects.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine (0.1 uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cell count", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cell count", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2700, + "assayComponentName": "CCTE_Mundy_HCI_hNP1_CellTiter", + "assayComponentDesc": "CCTE_Mundy_HCI_hNP1_CellTiter is one component of the CCTE_Mundy_HCI_hNP1_CellTiter assay. It measures cell viability related to ATP content using Luminescent Reporter.", + "assayComponentTargetDesc": "Changes in the ATP content are indicative of cell viability.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "cell viability", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "Luminescent Reporter", + "keyAssayReagentType": "luciferase assay", + "keyAssayReagent": "CellTiter-Glo assay buffer", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "ATP content", + "aid": 851, + "assayName": "CCTE_Mundy_HCI_hNP1_CellTiter", + "assayDesc": "CCTE_Mundy_HCI_hNP1_CellTiter is a multiplexed, cell-based-readout assay that uses neural stem cells derived from a neuroepithelial cell lineage of WA09 embryonic cells with measurements taken at 26.5 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 26.5, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural stem cells derived from a neuroepithelial cell lineage of WA09 embryonic cells", + "cellShortName": "hNP1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2797, + "assayComponentEndpointName": "CCTE_Mundy_HCI_hNP1_Pro_ResponderAvgInten", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_hNP1_Pro_ResponderAvgInten was analyzed at the endpoint CCTE_Mundy_HCI_hNP1_Pro_ResponderAvgInten in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of growth reporter, loss -of-signal activity can be used to understand viability effects.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "aphidicolin (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2710, + "assayComponentName": "CCTE_Mundy_HCI_hNP1_Pro_ResponderAvgInten", + "assayComponentDesc": "CCTE_Mundy_HCI_hNP1_Pro_ResponderAvgInten is one of three components of the CCTE_Mundy_HCI_hNP1_Pro assay. It measures proliferation related to percentage of BrdU positive cells using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the percentage of BrdU positive cells are indicative of cell proliferation.", + "parameterReadoutType": "single", + "assayDesignType": "growth reporter", + "assayDesignTypeSub": "proliferation", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Brdu antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "percentage of BrdU positive cells", + "aid": 853, + "assayName": "CCTE_Mundy_HCI_hNP1_Pro", + "assayDesc": "CCTE_Mundy_HCI_hNP1_Pro is a multiplexed, cell-based-readout assay that uses neural stem cells derived from a neuroepithelial cell lineage of WA09 embryonic cells with measurements taken at 26.25 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 26.25, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural stem cells derived from a neuroepithelial cell lineage of WA09 embryonic cells", + "cellShortName": "hNP1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 2808, + "assayComponentEndpointName": "UTOR_hL-FABP_binding_Kd", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component UTOR_hL-FABP_binding was analyzed into 1 assay endpoint. This assay enddpoint, UTOR_hL-FABP_binding_Kd, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, measures of fluorescence for loss-of-signal activity can be used to understand competitive binding of L-FABP. Furthermore, this assay endpoint can be referred to as the primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is fatty acid binding protein.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1,8-ANS", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "fatty acid binding protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2717, + "assayComponentName": "UTOR_hL-FABP_binding_Kd", + "assayComponentDesc": "UTOR_hL-FABP_binding_Kd is the calculated from the UTOR_hL-FABP_binding assay. It is a measuremnt of hL-FABP binding affinity as detected with fluorescence intensity signals by size-exclusion chromatography-co-elution (SECC) and nontarget analysis (NTA) technology by mass spectroscopy. An IC50 was obtained from dose-response curves and converted into its corresponding dissociation constant (Kd) concentration for tcpl processing as a single concentration value.", + "assayComponentTargetDesc": "Liver fatty acid binding protein (L-FABP) is a primarily expressed in the liver where it is involved in the binding, transport and metabolism of long-chain fatty acids and other hydrophobic molecules including xenobiotics like PFAS. The binding of PFAS to hL-FABP with increasing concentrations displaces 1-anilinonaphthalene-8-sulfonic acid (1,8-ANS) resulting in the loss of fluorescence intensity of the latter.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "fluorescence displacement", + "biologicalProcessTarget": "L-FABP binding affinity", + "detectionTechnologyType": "fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "size-exclusion chromatography-co-elution (SECC) and mass spectrometry using an LC-Orbitrap for non-targeted analysis (NTA)", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "1-anilinonaphthalene-8-sulfonic acid (1,8-ANS)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "hL-FABP protein-bound 1,8-ANS", + "aid": 855, + "assayName": "UTOR_hL-FABP_binding", + "assayDesc": "UTOR_hL-FABP_binding is a cell-free, single-readout assay that uses extracted liver fatty acid binding proteins (hL-FABP) from E. coli lysates with measurements taken at 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell-free", + "cellFreeComponentSource": "BL 21 (DE3) strain of E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "biochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "NA", + "dilutionSolventPercentMax": null, + "asid": 32, + "assaySourceName": "UTOR", + "assaySourceLongName": "University of Toronto, Peng Laboratory", + "assaySourceDesc": "The Peng Lab at the University of Toronto screened PFAS binding to hL-FABP through a Material Transfer Agreement for the PFAS screening library.", + "gene": { + "geneId": 124, + "geneName": "fatty acid binding protein 1, liver", + "description": null, + "geneSymbol": "FABP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2168, + "officialSymbol": "FABP1", + "officialFullName": "fatty acid binding protein 1, liver", + "uniprotAccessionNumber": "P07148" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.est.0c00049", + "url": "https://pubmed.ncbi.nlm.nih.gov/32249562/", + "pmid": 32249562, + "title": "Nontarget Screening of Per- and Polyfluoroalkyl Substances Binding to Human Liver Fatty Acid Binding Protein", + "author": "Yang D, Han J, Hall DR, Sun J, Fu J, Kutarna S, Houck KA, LaLone CA, Doering JA, Ng CA, Peng H", + "citation": "Yang D, Han J, Hall DR, Sun J, Fu J, Kutarna S, Houck KA, LaLone CA, Doering JA, Ng CA, Peng H. Nontarget Screening of Per- and Polyfluoroalkyl Substances Binding to Human Liver Fatty Acid Binding Protein. Environ Sci Technol. 2020 May 5;54(9):5676-5686. doi: 10.1021/acs.est.0c00049. Epub 2020 Apr 16. PMID: 32249562; PMCID: PMC7477755.", + "otherId": "0", + "citationId": 243, + "otherSource": "" + } + }, + { + "aeid": 2809, + "assayComponentEndpointName": "BSK_BT_Bcell_Proliferation", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BT_Bcell_Proliferation was analyzed at the endpoint, BSK_BT_Bcell_Proliferation, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain or loss-of-signal activity can be used to understand cellular changes in viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell cycle' intended target family, where the subfamily is 'proliferation'.", + "assayFunctionType": "viability", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1068, + "assayComponentName": "BSK_BT_Bcell_Proliferation", + "assayComponentDesc": "BSK_BT_Bcell_Proliferation is an assay component measured in the BSK_BT assay. It measures protein content, a form of viability reporter, as detected with absorbance signals by Sulforhodamine staining technology.", + "assayComponentTargetDesc": "B cell proliferation is a critical event driving both adaptive immunity (antibody production) as well as auto-immune diseases where B cells are key disease players (Lupus, MS, RA etc). Inhibition of B cell proliferation is considered an immune supressive effect.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 433, + "assayName": "BSK_BT", + "assayDesc": "BSK_BT is a cell-based, multiplexed-readout assay that uses B cell and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "B and peripheral blood mononuclear cells", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2811, + "assayComponentEndpointName": "BSK_BT_PBMCCytotoxicity", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BT_PBMCCytotoxicity was analyzed at the endpoint, BSK_BT_PBMCCytotoxicity, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain or loss-of-signal activity can be used to understand cellular changes in viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell cycle' intended target family, where the subfamily is 'cytotoxicity'.", + "assayFunctionType": "viability", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1069, + "assayComponentName": "BSK_BT_PBMCCytotoxicity", + "assayComponentDesc": "BSK_BT_PBMCCytotoxicity is an assay component measured in the BSK_BT assay. It measures dehydrogenase activity, a form of viability reporter, as detected with fluorescence intensity signals by Alamar Blue Reduction technology.", + "assayComponentTargetDesc": "PBMC Cytotoxicity in the BT system is a measure of the cell death of PBMC. Cell viability of non-adherent cells is measured by alamarBlue® staining, a method based on a cell permeable compound that emitts fluorescence after entering cells. The number of living cells is proportional to the amount of fluorescence produced", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dehydrogenase activity determination", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Alamar Blue Reduction", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Alamar blue", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "cellular", + "aid": 433, + "assayName": "BSK_BT", + "assayDesc": "BSK_BT is a cell-based, multiplexed-readout assay that uses B cell and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "B and peripheral blood mononuclear cells", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2813, + "assayComponentEndpointName": "BSK_BT_sIgG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BT_sIgG was analyzed at the endpoint, BSK_BT_sIgG, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of cytokine quantitation reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'immunoglobulin' intended target family, where the subfamily is 'IgG'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "immunoglobulin", + "intendedTargetFamilySub": "IgG", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1070, + "assayComponentName": "BSK_BT_sIgG", + "assayComponentDesc": "BSK_BT_sIgG is an assay component measured in the BSK_BT assay. It measures secreted IgG related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Secreted IgG (sIgG) is produced by B cells and is the main type of antibody found in blood and extracellular fluid that mediates the immune response against pathogens. sIgG is categorized as an immunomodulatory-related activity in the BT system modeling T cell depdendent B cell activation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "secreted IgG", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 433, + "assayName": "BSK_BT", + "assayDesc": "BSK_BT is a cell-based, multiplexed-readout assay that uses B cell and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "B and peripheral blood mononuclear cells", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 4172, + "geneName": "immunoglobulin heavy constant gamma 1 (G1m marker)", + "description": null, + "geneSymbol": "IGHG1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 3500, + "officialSymbol": "IGHG1", + "officialFullName": "immunoglobulin heavy constant gamma 1 (G1m marker)", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2815, + "assayComponentEndpointName": "BSK_BT_xIL17A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BT_xIL17A was analyzed at the endpoint, BSK_BT_xIL17A, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of cytokine quantitation reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'interleukins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1071, + "assayComponentName": "BSK_BT_xIL17A", + "assayComponentDesc": "BSK_BT_xIL17A is an assay component measured in the BSK_BT assay. It measures secreted IL-17A related to regulation of gene expression using LumineX xMAP technology.", + "assayComponentTargetDesc": "Interleukin 17A (IL-17A) is a proinflammatory cytokine produced by T cells that induces cytokine production and mediates monocyte and neutrophil recruitment to sites of inflammation. Secreted IL-17A (sIL-17A) is categorized as an immunomodulatory-related activity in the BT system modeling T cell depdendent B cell activation.", + "parameterReadoutType": "single", + "assayDesignType": "cytokine quantitation reporter", + "assayDesignTypeSub": "cytokine-specific antibody bead-based method", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LumineX xMAP", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "secreted IL-17A", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 433, + "assayName": "BSK_BT", + "assayDesc": "BSK_BT is a cell-based, multiplexed-readout assay that uses B cell and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "B and peripheral blood mononuclear cells", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 4248, + "geneName": "interleukin 17A", + "description": null, + "geneSymbol": "IL17A", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 3605, + "officialSymbol": "IL17A", + "officialFullName": "interleukin 17A", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2817, + "assayComponentEndpointName": "BSK_BT_xIL17F", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BT_xIL17F was analyzed at the endpoint, BSK_BT_xIL17F, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of cytokine quantitation reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'interleukins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1072, + "assayComponentName": "BSK_BT_xIL17F", + "assayComponentDesc": "BSK_BT_xIL17F is an assay component measured in the BSK_BT assay. It measures secreted IL-17F related to regulation of gene expression using LumineX xMAP technology.", + "assayComponentTargetDesc": "Interleukin 17F (IL-17F) is a proinflammatory cytokine produced by T cells that induces cytokine, chemokine and adhesion molecule production and mediates neutrophil recruitment to sites of inflammation. Secreted IL-17F (sIL-17F) is categorized as an immunomodulatory-related activity in the BT system modeling T cell depdendent B cell activation.", + "parameterReadoutType": "single", + "assayDesignType": "cytokine quantitation reporter", + "assayDesignTypeSub": "cytokine-specific antibody bead-based method", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LumineX xMAP", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "secreted IL-17F", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 433, + "assayName": "BSK_BT", + "assayDesc": "BSK_BT is a cell-based, multiplexed-readout assay that uses B cell and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "B and peripheral blood mononuclear cells", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 18205, + "geneName": "interleukin 17F", + "description": null, + "geneSymbol": "IL17F", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 112744, + "officialSymbol": "IL17F", + "officialFullName": "interleukin 17F", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2819, + "assayComponentEndpointName": "BSK_BT_xIL2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BT_xIL2 was analyzed at the endpoint, BSK_BT_xIL2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of cytokine quantitation reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'interleukins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1073, + "assayComponentName": "BSK_BT_xIL2", + "assayComponentDesc": "BSK_BT_xIL2 is an assay component measured in the BSK_BT assay. It measures secreted IL-2 related to regulation of gene expression using LumineX xMAP technology.", + "assayComponentTargetDesc": "Interleukin 2 (IL-2) is a secreted proinflammatory cytokine produced by T cells that regulates lymphocyte proliferation and promotes T cell differentiation. Secreted IL-2 (IL-2) is categorized as an immunomodulatory-related activity in the BT system modeling T cell depdendent B cell activation.", + "parameterReadoutType": "single", + "assayDesignType": "cytokine quantitation reporter", + "assayDesignTypeSub": "cytokine-specific antibody bead-based method", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LumineX xMAP", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "secreted IL-2", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 433, + "assayName": "BSK_BT", + "assayDesc": "BSK_BT is a cell-based, multiplexed-readout assay that uses B cell and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "B and peripheral blood mononuclear cells", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 4213, + "geneName": "interleukin 2", + "description": null, + "geneSymbol": "IL2", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 3558, + "officialSymbol": "IL2", + "officialFullName": "interleukin 2", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2821, + "assayComponentEndpointName": "BSK_BT_xIL6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BT_xIL6 was analyzed at the endpoint, BSK_BT_xIL6, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of cytokine quantitation reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'interleukins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1074, + "assayComponentName": "BSK_BT_xIL6", + "assayComponentDesc": "BSK_BT_xIL6 is an assay component measured in the BSK_BT assay. It measures secreted IL-6 related to regulation of gene expression using LumineX xMAP technology.", + "assayComponentTargetDesc": "Interleukin 6 (IL-6) is a secreted proinflammatory cytokine and acute phase reactant. Secreted IL-6 (sIL-6) is categorized as an immunomodulatory-related activity in the BT system modeling T cell depdendent B cell activation.", + "parameterReadoutType": "single", + "assayDesignType": "cytokine quantitation reporter", + "assayDesignTypeSub": "cytokine-specific antibody bead-based method", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LumineX xMAP", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "secreted IL-6", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 433, + "assayName": "BSK_BT", + "assayDesc": "BSK_BT is a cell-based, multiplexed-readout assay that uses B cell and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "B and peripheral blood mononuclear cells", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 175, + "geneName": "interleukin 6", + "description": null, + "geneSymbol": "IL6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3569, + "officialSymbol": "IL6", + "officialFullName": "interleukin 6", + "uniprotAccessionNumber": "P05231" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2823, + "assayComponentEndpointName": "BSK_BT_xTNFa", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BT_xTNFa was analyzed at the endpoint, BSK_BT_xTNFa, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of cytokine quantitation reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'inflammatory factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "inflammatory factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1075, + "assayComponentName": "BSK_BT_xTNFa", + "assayComponentDesc": "BSK_BT_xTNFa is an assay component of the BSK_BT assay. It measures secreted TNF-alpha related to regulation of gene expression using LumineX xMAP technology.", + "assayComponentTargetDesc": "Tumor necrosis factor alpha (TNF-alpha) is a secreted proinflammatory cytokine involved in Th1 inflammation. Secreted TNF-alpha is categorized as an inflammation-related activity in the BT system modeling T cell dependent B cell activation.", + "parameterReadoutType": "single", + "assayDesignType": "cytokine quantitation reporter", + "assayDesignTypeSub": "cytokine-specific antibody bead-based method", + "biologicalProcessTarget": "regulation of gene protein expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LumineX xMAP", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "secreted TNF-alpha", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 433, + "assayName": "BSK_BT", + "assayDesc": "BSK_BT is a cell-based, multiplexed-readout assay that uses B cell and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "B and peripheral blood mononuclear cells", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 327, + "geneName": "tumor necrosis factor", + "description": null, + "geneSymbol": "TNF", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7124, + "officialSymbol": "TNF", + "officialFullName": "tumor necrosis factor", + "uniprotAccessionNumber": "P01375" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2825, + "assayComponentEndpointName": "BSK_MyoF_ACTA1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_MyoF_ACTA1 was analyzed at the endpoint, BSK_MyoF_ACTA1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'actin'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "actin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1081, + "assayComponentName": "BSK_MyoF_ACTA1", + "assayComponentDesc": "BSK_MyoF_ACTA1 is an assay component measured in the BSK_MyoF assay. It measures a-SMA antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "alpha-Smooth muscle actin (a-SMA) is a protein involved in muscle contraction, cell motility, structure and integrity and is a marker for activated myofibroblast phenotype. a-SMA is categorized as a tissue remodeling-related activity in the MyoF system modeling pulmonary myofibroblast development.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "a-SMA antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 435, + "assayName": "BSK_MyoF", + "assayDesc": "BSK_MyoF is a cell-based, multiplexed-readout assay that uses lung fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "lung fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 1526, + "geneName": "actin, alpha 1, skeletal muscle", + "description": null, + "geneSymbol": "ACTA1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 58, + "officialSymbol": "ACTA1", + "officialFullName": "actin, alpha 1, skeletal muscle", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2827, + "assayComponentEndpointName": "BSK_MyoF_bFGF", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_MyoF_bFGF was analyzed at the endpoint, BSK_MyoF_bFGF, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'growth factor' intended target family, where the subfamily is 'basic fibroblast growth factor '.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "growth factor", + "intendedTargetFamilySub": "basic fibroblast growth factor ", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1082, + "assayComponentName": "BSK_MyoF_bFGF", + "assayComponentDesc": "BSK_MyoF_bFGF is an assay component measured in the BSK_MyoF assay. It measures bFGF antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Basic fibroblast growth factor (bFGF) is a pro-fibrotic growth factor that drives fibroblast proliferation, migration and fibronectin synthesis. bFGF is categorized as a tissue remodeling-related activity in the MyoF system modeling pulmonary myofibroblast development.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "bFGF antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 435, + "assayName": "BSK_MyoF", + "assayDesc": "BSK_MyoF is a cell-based, multiplexed-readout assay that uses lung fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "lung fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 3172, + "geneName": "fibroblast growth factor 2", + "description": null, + "geneSymbol": "FGF2", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 2247, + "officialSymbol": "FGF2", + "officialFullName": "fibroblast growth factor 2", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2829, + "assayComponentEndpointName": "BSK_MyoF_VCAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_MyoF_VCAM1 was analyzed at the endpoint, BSK_MyoF_VCAM1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'Immunoglobulin CAM'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1083, + "assayComponentName": "BSK_MyoF_VCAM1", + "assayComponentDesc": "BSK_MyoF_VCAM1 is an assay component measured in the BSK_MyoF assay. It measures VCAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Vascular Cell Adhesion Molecule 1 (VCAM-1/CD106) is a cell adhesion molecule that mediates adhesion of monocytes and T cells to endothelial cells. VCAM-1 is categorized as an inflammation-related activity in the MyoF system modeling pulmonary myofibroblast development.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "VCAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 435, + "assayName": "BSK_MyoF", + "assayDesc": "BSK_MyoF is a cell-based, multiplexed-readout assay that uses lung fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "lung fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 334, + "geneName": "vascular cell adhesion molecule 1", + "description": null, + "geneSymbol": "VCAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7412, + "officialSymbol": "VCAM1", + "officialFullName": "vascular cell adhesion molecule 1", + "uniprotAccessionNumber": "P19320" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2831, + "assayComponentEndpointName": "BSK_MyoF_CollagenI", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_MyoF_CollagenI was analyzed at the endpoint, BSK_MyoF_CollagenI, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'collagen'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "collagen", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1084, + "assayComponentName": "BSK_MyoF_CollagenI", + "assayComponentDesc": "BSK_MyoF_CollagenI is an assay component measured in the BSK_MyoF assay. It measures Collagen I antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Collagen I is involved in tissue remodeling and fibrosis, and is the most common fibrillar collagen that is found in skin, bone, tendons and other connective tissues. Collagen I is categorized a tissue remodeling-related activity in the MyoF system modeling pulmonary myofibroblast development.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Collagen I antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 435, + "assayName": "BSK_MyoF", + "assayDesc": "BSK_MyoF is a cell-based, multiplexed-readout assay that uses lung fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "lung fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 2452, + "geneName": "collagen type I alpha 1 chain", + "description": null, + "geneSymbol": "COL1A1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 1277, + "officialSymbol": "COL1A1", + "officialFullName": "collagen type I alpha 1 chain", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2833, + "assayComponentEndpointName": "BSK_MyoF_CollagenIII", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_MyoF_CollagenIII was analyzed at the endpoint, BSK_MyoF_CollagenIII, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'collagen'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "collagen", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1085, + "assayComponentName": "BSK_MyoF_CollagenIII", + "assayComponentDesc": "BSK_MyoF_CollagenIII is an assay component measured in the BSK_MyoF assay. It measures Collagen III antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Collagen III is an extracellular matrix protein and fibrillar collagen found in extensible connective tissues (skin, lung and vascular system) and is involved in cell adhesion, cell migration, tissue remodeling. Collagen III is categorized a tissue remodeling-related activity in the MyoF system modeling pulmonary myofibroblast development.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Collagen III antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 435, + "assayName": "BSK_MyoF", + "assayDesc": "BSK_MyoF is a cell-based, multiplexed-readout assay that uses lung fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "lung fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 70, + "geneName": "collagen, type III, alpha 1", + "description": null, + "geneSymbol": "COL3A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1281, + "officialSymbol": "COL3A1", + "officialFullName": "collagen, type III, alpha 1", + "uniprotAccessionNumber": "P02461" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2835, + "assayComponentEndpointName": "BSK_MyoF_CollagenIV", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_MyoF_CollagenIV was analyzed at the endpoint, BSK_MyoF_CollagenIV, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'collagen'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "collagen", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1086, + "assayComponentName": "BSK_MyoF_CollagenIV", + "assayComponentDesc": "BSK_MyoF_CollagenIV is an assay component measured in the BSK_MyoF assay. It measures Collagen IV antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Collagen IV is the major structural component of the basal lamina. Collagen IV is categorized a tissue remodeling-related activity in the MyoF system modeling pulmonary myofibroblast development.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Collagen IV antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 435, + "assayName": "BSK_MyoF", + "assayDesc": "BSK_MyoF is a cell-based, multiplexed-readout assay that uses lung fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "lung fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 2456, + "geneName": "collagen type IV alpha 1 chain", + "description": null, + "geneSymbol": "COL4A1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 1282, + "officialSymbol": "COL4A1", + "officialFullName": "collagen type IV alpha 1 chain", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2837, + "assayComponentEndpointName": "BSK_MyoF_IL8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_MyoF_IL8 was analyzed at the endpoint, BSK_MyoF_IL8, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'interleukins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1087, + "assayComponentName": "BSK_MyoF_IL8", + "assayComponentDesc": "BSK_MyoF_IL8 is an assay component measured in the BSK_MyoF assay. It measures IL-8 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Interleukin 8 (IL-8/CXCL8) is a chemokine that mediates neutrophil recruitment into acute inflammatory sites. IL-8 is categorized as an inflammation-related activity in the MyoF system modeling pulmonary myofibroblast development.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-8 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 435, + "assayName": "BSK_MyoF", + "assayDesc": "BSK_MyoF is a cell-based, multiplexed-readout assay that uses lung fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "lung fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 177, + "geneName": "chemokine (C-X-C motif) ligand 8", + "description": null, + "geneSymbol": "CXCL8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3576, + "officialSymbol": "CXCL8", + "officialFullName": "chemokine (C-X-C motif) ligand 8", + "uniprotAccessionNumber": "P10145" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2839, + "assayComponentEndpointName": "BSK_MyoF_Decorin", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_MyoF_Decorin was analyzed at the endpoint, BSK_MyoF_Decorin, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'decorin'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "decorin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1088, + "assayComponentName": "BSK_MyoF_Decorin", + "assayComponentDesc": "BSK_MyoF_Decorin is an assay component measured in the BSK_MyoF assay. It measures Decorin antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Decorin is a proteoglycan that is a component of connective tissue and is involved in collagen and matrix assembly. Decorin is categorized as a tissue remodeling-related activity in the MyoF system modeling pulmonary myofibroblast development.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Decorin antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 435, + "assayName": "BSK_MyoF", + "assayDesc": "BSK_MyoF is a cell-based, multiplexed-readout assay that uses lung fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "lung fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 2723, + "geneName": "decorin", + "description": null, + "geneSymbol": "DCN", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 1634, + "officialSymbol": "DCN", + "officialFullName": "decorin", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2841, + "assayComponentEndpointName": "BSK_MyoF_MMP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_MyoF_MMP1 was analyzed at the endpoint, BSK_MyoF_MMP1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'protease' intended target family, where the subfamily is 'matrix metalloproteinase'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1089, + "assayComponentName": "BSK_MyoF_MMP1", + "assayComponentDesc": "BSK_MyoF_MMP1 is an assay component measured in the BSK_MyoF assay. It measures PAI-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Matrix metalloproteinase-1 (MMP-1) is an interstitial collagenase that degrades collagens I, II and III and is involved in the process of tissue remodeling. MMP-1 is categorized as a tissue remodeling-related activity in the MyoF system modeling pulmonary myofibroblast development.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "PAI-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 435, + "assayName": "BSK_MyoF", + "assayDesc": "BSK_MyoF is a cell-based, multiplexed-readout assay that uses lung fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "lung fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 203, + "geneName": "matrix metallopeptidase 1 (interstitial collagenase)", + "description": null, + "geneSymbol": "MMP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4312, + "officialSymbol": "MMP1", + "officialFullName": "matrix metallopeptidase 1 (interstitial collagenase)", + "uniprotAccessionNumber": "P03956" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2843, + "assayComponentEndpointName": "BSK_MyoF_PAI1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_MyoF_PAI1 was analyzed at the endpoint, BSK_MyoF_PAI1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'plasmogen activator inhibitor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "plasmogen activator inhibitor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1090, + "assayComponentName": "BSK_MyoF_PAI1", + "assayComponentDesc": "BSK_MyoF_PAI1 is an assay component measured in the BSK_MyoF assay. It measures PAI-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Plasminogen activator inhibitor-1 (PAI-I) is a serine proteinase inhibitor and inhibitor of tissue plasminogen activator (tPA) and urokinase (uPA) and is involved in tissue remodeling and fibrinolysis. PAI-I is categorized as a tissue remodeling-related activity in the MyoF system modeling pulmonary myofibroblast development.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "PAI-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 435, + "assayName": "BSK_MyoF", + "assayDesc": "BSK_MyoF is a cell-based, multiplexed-readout assay that uses lung fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "lung fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 229, + "geneName": "serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1", + "description": null, + "geneSymbol": "SERPINE1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5054, + "officialSymbol": "SERPINE1", + "officialFullName": "serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1", + "uniprotAccessionNumber": "P05121" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2845, + "assayComponentEndpointName": "BSK_MyoF_SRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_MyoF_SRB was analyzed at the endpoint, BSK_MyoF_SRB, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell morphology' intended target family, where the subfamily is 'cell conformation'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1091, + "assayComponentName": "BSK_MyoF_SRB", + "assayComponentDesc": "BSK_MyoF_SRB is an assay component measured in the BSK_MyoF assay. It measures 0.1% sulforhodamine related to cell death using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "SRB in the MyoF system is a measure of the total protein content of lung fibroblasts. Cell viability of adherent cells is measured by Sulforhodamine B (SRB) staining, a method that determines cell density by measuring total protein content of test wells.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 435, + "assayName": "BSK_MyoF", + "assayDesc": "BSK_MyoF is a cell-based, multiplexed-readout assay that uses lung fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "lung fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2847, + "assayComponentEndpointName": "BSK_MyoF_TIMP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_MyoF_TIMP1 was analyzed at the endpoint, BSK_MyoF_TIMP1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'protease' intended target family, where the subfamily is 'matrix metalloproteinase'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1092, + "assayComponentName": "BSK_MyoF_TIMP1", + "assayComponentDesc": "BSK_MyoF_TIMP1 is an assay component measured in the BSK_MyoF assay. It measures TIMP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "TIMP-1 is a tissue inhibitor of matrix metalloprotease-7 (MMP-7) and other MMPs, and is involved in tissue remodeling, angiogenesis and fibrosis. TIMP-1 is categorized as a tissue remodeling-related activity in the MyoF system modeling pulmonary myofibroblast development.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TIMP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 435, + "assayName": "BSK_MyoF", + "assayDesc": "BSK_MyoF is a cell-based, multiplexed-readout assay that uses lung fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "lung fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 324, + "geneName": "TIMP metallopeptidase inhibitor 1", + "description": null, + "geneSymbol": "TIMP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7076, + "officialSymbol": "TIMP1", + "officialFullName": "TIMP metallopeptidase inhibitor 1", + "uniprotAccessionNumber": "P01033" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2849, + "assayComponentEndpointName": "BSK_BF4T_MCP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_MCP1 was analyzed at the endpoint, BSK_BF4T_MCP1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'chemotactic factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2719, + "assayComponentName": "BSK_BF4T_MCP1", + "assayComponentDesc": "BSK_BF4T_MCP1 is an assay component measured in the BSK_BF4T assay. It measures MCP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Monocyte chemoattractant protein-1 (MCP-1/CCL2) is a chemoattractant cytokine (chemokine) that regulates the recruitment of monocytes and T cells into sites of inflammation. MCP-1 is categorized as an inflammation-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MCP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 291, + "geneName": "chemokine (C-C motif) ligand 2", + "description": null, + "geneSymbol": "CCL2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6347, + "officialSymbol": "CCL2", + "officialFullName": "chemokine (C-C motif) ligand 2", + "uniprotAccessionNumber": "P13500" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2851, + "assayComponentEndpointName": "BSK_BF4T_Eotaxin3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_Eotaxin3 was analyzed at the endpoint, BSK_BF4T_Eotaxin3, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'chemotactic factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2720, + "assayComponentName": "BSK_BF4T_Eotaxin3", + "assayComponentDesc": "BSK_BF4T_Eotaxin3 is an assay component measured in the BSK_BF4T assay. It measures Eotaxin-3 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Eotaxin-3/CCL26 is a chemokine that mediates recruitment of eosinophils and basophils into tissue sites. Eotaxin-3 is categorized as an inflammation-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Eotaxin-3 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 365, + "geneName": "chemokine (C-C motif) ligand 26", + "description": null, + "geneSymbol": "CCL26", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10344, + "officialSymbol": "CCL26", + "officialFullName": "chemokine (C-C motif) ligand 26", + "uniprotAccessionNumber": "Q9Y258" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2853, + "assayComponentEndpointName": "BSK_BF4T_VCAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_VCAM1 was analyzed at the endpoint, BSK_BF4T_VCAM1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'Immunoglobulin CAM'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2721, + "assayComponentName": "BSK_BF4T_VCAM1", + "assayComponentDesc": "BSK_BF4T_VCAM1 is an assay component measured in the BSK_BF4T assay. It measures VCAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Vascular Cell Adhesion Molecule 1 (VCAM-1/CD106) is a cell adhesion molecule that mediates adhesion of monocytes and T cells to endothelial cells. VCAM-1 is categorized as an inflammation-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "VCAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 334, + "geneName": "vascular cell adhesion molecule 1", + "description": null, + "geneSymbol": "VCAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7412, + "officialSymbol": "VCAM1", + "officialFullName": "vascular cell adhesion molecule 1", + "uniprotAccessionNumber": "P19320" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2855, + "assayComponentEndpointName": "BSK_BF4T_ICAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_ICAM1 was analyzed at the endpoint, BSK_BF4T_ICAM1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'Immunoglobulin CAM'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2722, + "assayComponentName": "BSK_BF4T_ICAM1", + "assayComponentDesc": "BSK_BF4T_ICAM1 is an assay component measured in the BSK_BF4T assay. It measures ICAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Intercellular Adhesion Molecule 1 (ICAM-1/CD54) is a cell adhesion molecule that mediates leukocyte-endothelial cell adhesion and leukocyte recruitment. ICAM-1 is categorized as an inflammation-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "ICAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 170, + "geneName": "intercellular adhesion molecule 1", + "description": null, + "geneSymbol": "ICAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3383, + "officialSymbol": "ICAM1", + "officialFullName": "intercellular adhesion molecule 1", + "uniprotAccessionNumber": "P05362" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2857, + "assayComponentEndpointName": "BSK_BF4T_CD90", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_CD90 was analyzed at the endpoint, BSK_BF4T_CD90, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'inflammatory factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "inflammatory factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2723, + "assayComponentName": "BSK_BF4T_CD90", + "assayComponentDesc": "BSK_BF4T_CD90 is an assay component measured in the BSK_BF4T assay. It measures CD90 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "CD90 is a cell surface glycoprotein that mediates cell-cell and cell-matrix interactions. CD90 is categorized as a tissue remodeling-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD90 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 6890, + "geneName": "Thy-1 cell surface antigen", + "description": null, + "geneSymbol": "THY1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 7070, + "officialSymbol": "THY1", + "officialFullName": "Thy-1 cell surface antigen", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2859, + "assayComponentEndpointName": "BSK_BF4T_IL8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_IL8 was analyzed at the endpoint, BSK_BF4T_IL8, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'interleukins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2724, + "assayComponentName": "BSK_BF4T_IL8", + "assayComponentDesc": "BSK_BF4T_IL8 is an assay component measured in the BSK_BF4T assay. It measures IL-8 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Interleukin 8 (IL-8/CXCL8) is a chemokine that mediates neutrophil recruitment into acute inflammatory sites. IL-8 is categorized as an inflammation-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-8 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 177, + "geneName": "chemokine (C-X-C motif) ligand 8", + "description": null, + "geneSymbol": "CXCL8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3576, + "officialSymbol": "CXCL8", + "officialFullName": "chemokine (C-X-C motif) ligand 8", + "uniprotAccessionNumber": "P10145" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2861, + "assayComponentEndpointName": "BSK_BF4T_IL1a", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_IL1a was analyzed at the endpoint, BSK_BF4T_IL1a, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'interleukins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2725, + "assayComponentName": "BSK_BF4T_IL1a", + "assayComponentDesc": "BSK_BF4T_IL1a is an assay component measured in the BSK_BF4T assay. It measures IL-1a antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Interleukin 1 alpha (IL-1a) is a secreted proinflammatory cytokine involved in endothelial cell activation and neutrophil recruitment. Secreted IL-1? (sIL-1?)is categorized as an inflammation-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-1a antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 174, + "geneName": "interleukin 1, alpha", + "description": null, + "geneSymbol": "IL1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3552, + "officialSymbol": "IL1A", + "officialFullName": "interleukin 1, alpha", + "uniprotAccessionNumber": "P01583" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2863, + "assayComponentEndpointName": "BSK_BF4T_Keratin818", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_Keratin818 was analyzed at the endpoint, BSK_BF4T_Keratin818, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'keratin'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "keratin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2726, + "assayComponentName": "BSK_BF4T_Keratin818", + "assayComponentDesc": "BSK_BF4T_Keratin818 is an assay component measured in the BSK_BF4T assay. It measures Keratin 8/18 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Keratin 8/18 is an intermediate filament heterodimer of fibrous structural poteins involved in Epithelial cell death, EMT, COPD, Lung Inflammation. Keratin 8/18 is categorized as a tissue remodeling-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Keratin 8/18 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 4459, + "geneName": "keratin 18", + "description": null, + "geneSymbol": "KRT18", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 3875, + "officialSymbol": "KRT18", + "officialFullName": "keratin 18", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2865, + "assayComponentEndpointName": "BSK_BF4T_MMP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_MMP1 was analyzed at the endpoint, BSK_BF4T_MMP1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'protease' intended target family, where the subfamily is 'matrix metalloproteinase'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2727, + "assayComponentName": "BSK_BF4T_MMP1", + "assayComponentDesc": "BSK_BF4T_MMP1 is an assay component measured in the BSK_BF4T assay. It measures MMP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Matrix metalloproteinase-1 (MMP-1) is an interstitial collagenase that degrades collagens I, II and III and is involved in the process of tissue remodeling. MMP-1 is categorized as a tissue remodeling-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MMP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 203, + "geneName": "matrix metallopeptidase 1 (interstitial collagenase)", + "description": null, + "geneSymbol": "MMP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4312, + "officialSymbol": "MMP1", + "officialFullName": "matrix metallopeptidase 1 (interstitial collagenase)", + "uniprotAccessionNumber": "P03956" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2867, + "assayComponentEndpointName": "BSK_BF4T_MMP3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_MMP3 was analyzed at the endpoint, BSK_BF4T_MMP3, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'protease' intended target family, where the subfamily is 'matrix metalloproteinase'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2728, + "assayComponentName": "BSK_BF4T_MMP3", + "assayComponentDesc": "BSK_BF4T_MMP3 is an assay component measured in the BSK_BF4T assay. It measures MMP-3 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Matrix metalloproteinase-3 (MMP-3) is an enzyme involved in tissue remodeling that can activate other MMPs (MMP-1, MMP-7 and MMP-9) and degrade collagens (II, III, IV, IX and X), proteoglycans, fibronectin, laminin and elastin. MMP-3 is categorized as a tissue remodeling-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MMP-3 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 205, + "geneName": "matrix metallopeptidase 3 (stromelysin 1, progelatinase)", + "description": null, + "geneSymbol": "MMP3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4314, + "officialSymbol": "MMP3", + "officialFullName": "matrix metallopeptidase 3 (stromelysin 1, progelatinase)", + "uniprotAccessionNumber": "P08254" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2869, + "assayComponentEndpointName": "BSK_BF4T_MMP9", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_MMP9 was analyzed at the endpoint, BSK_BF4T_MMP9, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'protease' intended target family, where the subfamily is 'matrix metalloproteinase'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2729, + "assayComponentName": "BSK_BF4T_MMP9", + "assayComponentDesc": "BSK_BF4T_MMP9 is an assay component measured in the BSK_BF4T assay. It measures MMP-9 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Matrix metalloproteinase-9 (MMP-9) is a gelatinase B that degrades collagen IV and gelatin and is involved in airway matrix remodeling. MMP-9 is categorized as a tissue remodeling-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MMP-9 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 207, + "geneName": "matrix metallopeptidase 9 (gelatinase B, 92kDa gelatinase, 92kDa type IV collagenase)", + "description": null, + "geneSymbol": "MMP9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4318, + "officialSymbol": "MMP9", + "officialFullName": "matrix metallopeptidase 9 (gelatinase B, 92kDa gelatinase, 92kDa type IV collagenase)", + "uniprotAccessionNumber": "P14780" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2871, + "assayComponentEndpointName": "BSK_BF4T_PAI1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_PAI1 was analyzed at the endpoint, BSK_BF4T_PAI1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'plasmogen activator inhibitor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "plasmogen activator inhibitor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2730, + "assayComponentName": "BSK_BF4T_PAI1", + "assayComponentDesc": "BSK_BF4T_PAI1 is an assay component measured in the BSK_BF4T assay. It measures PAI-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Plasminogen activator inhibitor-1 (PAI-I) is a serine proteinase inhibitor and inhibitor of tissue plasminogen activator (tPA) and urokinase (uPA) and is involved in tissue remodeling and fibrinolysis. PAI-I is categorized as a tissue remodeling-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "PAI-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 229, + "geneName": "serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1", + "description": null, + "geneSymbol": "SERPINE1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5054, + "officialSymbol": "SERPINE1", + "officialFullName": "serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1", + "uniprotAccessionNumber": "P05121" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2873, + "assayComponentEndpointName": "BSK_BF4T_SRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_SRB was analyzed at the endpoint, BSK_BF4T_SRB, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell morphology' intended target family, where the subfamily is 'cell conformation'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2731, + "assayComponentName": "BSK_BF4T_SRB", + "assayComponentDesc": "BSK_BF4T_SRB is an assay component measured in the BSK_BF4T assay. It measures 0.1% sulforhodamine related to cell death using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "SRB in the BF4T system is a measure of the total protein content of bronchial epithelial cells and dermal fibroblasts. Cell viability of adherent cells is measured by Sulforhodamine B (SRB) staining, a method that determines cell density by measuring total protein content of test wells.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2875, + "assayComponentEndpointName": "BSK_BF4T_tPA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4T_tPA was analyzed at the endpoint, BSK_BF4T_tPA, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'protease' intended target family, where the subfamily is 'serine protease'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "serine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2732, + "assayComponentName": "BSK_BF4T_tPA", + "assayComponentDesc": "BSK_BF4T_tPA is an assay component measured in the BSK_BF4T assay. It measures tPA antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Tissue plasminogen activator (tPA) is a serine protease that catalyzes the cleavage of plasminogen to plasmin and regulates clot degradation. tPA is involved in fibrinolyis, cell migration and tissue remodeling. tPA is categorized as a tissue remodeling-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "tPA antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 239, + "geneName": "plasminogen activator, tissue", + "description": null, + "geneSymbol": "PLAT", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5327, + "officialSymbol": "PLAT", + "officialFullName": "plasminogen activator, tissue", + "uniprotAccessionNumber": "P00750" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2877, + "assayComponentEndpointName": "BSK_BF4T_uPA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BF4TA was analyzed at the endpoint, BSK_BF4TA, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'protease' intended target family, where the subfamily is 'serine protease'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "serine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2733, + "assayComponentName": "BSK_BF4T_uPA", + "assayComponentDesc": "BSK_BF4TA is an assay component measured in the BSK_BF4T assay. It measures uPA antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Urokinse plasminogen activator (uPA) is a serine protease with thrombolytic activity. Triggers fibrinolysis and extracellular matrix degradation. uPA is categorized as a tissue remodeling-related activity in the BF4T system modeling Th2 airway inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "uPA antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 857, + "assayName": "BSK_BF4T", + "assayDesc": "BSK_BF4T is a cell-based, multiplexed-readout assay that uses bronchial epithelial cells and dermal fibroblasts, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells and dermal fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 240, + "geneName": "plasminogen activator, urokinase", + "description": null, + "geneSymbol": "PLAU", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5328, + "officialSymbol": "PLAU", + "officialFullName": "plasminogen activator, urokinase", + "uniprotAccessionNumber": "P00749" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2879, + "assayComponentEndpointName": "BSK_BE3C_ICAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_ICAM1 was analyzed at the endpoint, BSK_BE3C_ICAM1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'Immunoglobulin CAM'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2734, + "assayComponentName": "BSK_BE3C_ICAM1", + "assayComponentDesc": "BSK_BE3C_ICAM1 is an assay component measured in the BSK_BE3C assay. It measures ICAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Intercellular Adhesion Molecule 1 (ICAM-1/CD54) is a cell adhesion molecule that mediates leukocyte-endothelial cell adhesion and leukocyte recruitment. ICAM-1 is categorized as an inflammation-related activity in the BE3C system modeling Th1 lung inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "ICAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 170, + "geneName": "intercellular adhesion molecule 1", + "description": null, + "geneSymbol": "ICAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3383, + "officialSymbol": "ICAM1", + "officialFullName": "intercellular adhesion molecule 1", + "uniprotAccessionNumber": "P05362" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2881, + "assayComponentEndpointName": "BSK_BE3C_ITAC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_ITAC was analyzed at the endpoint, BSK_BE3C_ITAC, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'chemotactic factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2735, + "assayComponentName": "BSK_BE3C_ITAC", + "assayComponentDesc": "BSK_BE3C_ITAC is an assay component measured in the BSK_BE3C assay. It measures I-TAC antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Interferon inducible T Cell Alpha Chemoattractant (I-TAC/CXCL11) is a chemokine that mediates T cell and monocyte chemotaxis. I-TAC is categorized as an inflammation-related activity in the BE3C system modeling Th1 lung inflammation. ", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "I-TAC antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 6313, + "geneName": "C-X-C motif chemokine ligand 11", + "description": null, + "geneSymbol": "CXCL11", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 6373, + "officialSymbol": "CXCL11", + "officialFullName": "C-X-C motif chemokine ligand 11", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2883, + "assayComponentEndpointName": "BSK_BE3C_IL8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_IL8 was analyzed at the endpoint, BSK_BE3C_IL8, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'interleukins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2736, + "assayComponentName": "BSK_BE3C_IL8", + "assayComponentDesc": "BSK_BE3C_IL8 is an assay component measured in the BSK_BE3C assay. It measures IL-8 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Interleukin 8 (IL-8/CXCL8) is a chemokine that mediates neutrophil recruitment into acute inflammatory sites. IL-8 is categorized as an inflammation-related activity in the BE3C system modeling Th1 lung inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-8 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 177, + "geneName": "chemokine (C-X-C motif) ligand 8", + "description": null, + "geneSymbol": "CXCL8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3576, + "officialSymbol": "CXCL8", + "officialFullName": "chemokine (C-X-C motif) ligand 8", + "uniprotAccessionNumber": "P10145" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 1943, + "assayComponentEndpointName": "ATG_M_06_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, ATG_M_06_XSP1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1871, + "assayComponentName": "ATG_M_06_XSP1", + "assayComponentDesc": "ATG_M_06_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_06, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M06 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2885, + "assayComponentEndpointName": "BSK_BE3C_EGFR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_EGFR was analyzed at the endpoint, BSK_BE3C_EGFR, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'kinase' intended target family, where the subfamily is 'receptor tyrosine kinase'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2737, + "assayComponentName": "BSK_BE3C_EGFR", + "assayComponentDesc": "BSK_BE3C_EGFR is an assay component measured in the BSK_BE3C assay. It measures EGFR antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Epidermal growth factor receptor (EGFR) is a cell surface receptor for epidermal growth factor involved in cell proliferation, cell differentiation, tissue remodeling and tumor growth. EGFR is categorized as a tissue remodeling-related activity in the BE3C system modeling Th1 lung inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "EGFR antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 108, + "geneName": "epidermal growth factor receptor", + "description": null, + "geneSymbol": "EGFR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1956, + "officialSymbol": "EGFR", + "officialFullName": "epidermal growth factor receptor", + "uniprotAccessionNumber": "P00533" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2887, + "assayComponentEndpointName": "BSK_BE3C_Keratin818", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_Keratin818 was analyzed at the endpoint, BSK_BE3C_Keratin818, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'keratin'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "keratin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2738, + "assayComponentName": "BSK_BE3C_Keratin818", + "assayComponentDesc": "BSK_BE3C_Keratin818 is an assay component measured in the BSK_BE3C assay. It measures Keratin 8/18 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Keratin 8/18 is an intermediate filament heterodimer of fibrous structural poteins involved in Epithelial cell death, EMT, COPD, Lung Inflammation. Keratin 8/18 is categorized as a tissue remodeling-related activity in the BE3C system modeling Th1 lung inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Keratin 8/18 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 4459, + "geneName": "keratin 18", + "description": null, + "geneSymbol": "KRT18", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 3875, + "officialSymbol": "KRT18", + "officialFullName": "keratin 18", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2889, + "assayComponentEndpointName": "BSK_BE3C_MMP9", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_MMP9 was analyzed at the endpoint, BSK_BE3C_MMP9, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'protease' intended target family, where the subfamily is 'matrix metalloproteinase'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2739, + "assayComponentName": "BSK_BE3C_MMP9", + "assayComponentDesc": "BSK_BE3C_MMP9 is an assay component measured in the BSK_BE3C assay. It measures MMP-9 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Matrix metalloproteinase-9 (MMP-9) is a gelatinase B that degrades collagen IV and gelatin and is involved in airway matrix remodeling. MMP-9 is categorized as a tissue remodeling-related activity in the BE3C system modeling Th1 lung inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MMP-9 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 207, + "geneName": "matrix metallopeptidase 9 (gelatinase B, 92kDa gelatinase, 92kDa type IV collagenase)", + "description": null, + "geneSymbol": "MMP9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4318, + "officialSymbol": "MMP9", + "officialFullName": "matrix metallopeptidase 9 (gelatinase B, 92kDa gelatinase, 92kDa type IV collagenase)", + "uniprotAccessionNumber": "P14780" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2891, + "assayComponentEndpointName": "BSK_CASM3C_PAI1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_PAI1 was analyzed at the endpoint, BSK_CASM3C_PAI1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'plasmogen activator inhibitor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "plasmogen activator inhibitor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2740, + "assayComponentName": "BSK_CASM3C_PAI1", + "assayComponentDesc": "BSK_CASM3C_PAI1 is an assay component measured in the BSK_CASM3C assay. It measures PAI-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Plasminogen activator inhibitor-1 (PAI-I) is a serine proteinase inhibitor and inhibitor of tissue plasminogen activator (tPA) and urokinase (uPA) and is involved in tissue remodeling and fibrinolysis. PAI-I is categorized as a tissue remodeling-related activity in the CASM3C system modeling Th1 vascular smooth muscle inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "PAI-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 229, + "geneName": "serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1", + "description": null, + "geneSymbol": "SERPINE1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5054, + "officialSymbol": "SERPINE1", + "officialFullName": "serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1", + "uniprotAccessionNumber": "P05121" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2893, + "assayComponentEndpointName": "BSK_hDFCGF_MCP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_MCP1 was analyzed at the endpoint, BSK_hDFCGF_MCP1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'chemotactic factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2741, + "assayComponentName": "BSK_hDFCGF_MCP1", + "assayComponentDesc": "BSK_hDFCGF_MCP1 is an assay component measured in the BSK_hDFCGF assay. It measures MCP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Monocyte chemoattractant protein-1 (MCP-1/CCL2) is a chemoattractant cytokine (chemokine) that regulates the recruitment of monocytes and T cells into sites of inflammation. MCP-1 is categorized as an inflammation-related activity in the HDF3CGF system modeling Th1 inflammation involved in wound healing and matrix remodeling of the skin.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MCP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 291, + "geneName": "chemokine (C-C motif) ligand 2", + "description": null, + "geneSymbol": "CCL2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6347, + "officialSymbol": "CCL2", + "officialFullName": "chemokine (C-C motif) ligand 2", + "uniprotAccessionNumber": "P13500" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2895, + "assayComponentEndpointName": "BSK_hDFCGF_ICAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_ICAM1 was analyzed at the endpoint, BSK_hDFCGF_ICAM1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'Immunoglobulin CAM'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2742, + "assayComponentName": "BSK_hDFCGF_ICAM1", + "assayComponentDesc": "BSK_hDFCGF_ICAM1 is an assay component measured in the BSK_hDFCGF assay. It measures ICAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Intercellular Adhesion Molecule 1 (ICAM-1/CD54) is a cell adhesion molecule that mediates leukocyte-endothelial cell adhesion and leukocyte recruitment. ICAM-1 is categorized as an inflammation-related activity in the HDF3CGF system modeling Th1 inflammation involved in wound healing and matrix remodeling of the skin.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "ICAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 170, + "geneName": "intercellular adhesion molecule 1", + "description": null, + "geneSymbol": "ICAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3383, + "officialSymbol": "ICAM1", + "officialFullName": "intercellular adhesion molecule 1", + "uniprotAccessionNumber": "P05362" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2897, + "assayComponentEndpointName": "BSK_hDFCGF_CollagenI", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_CollagenI was analyzed at the endpoint, BSK_hDFCGF_CollagenI, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'collagen'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "collagen", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2743, + "assayComponentName": "BSK_hDFCGF_CollagenI", + "assayComponentDesc": "BSK_hDFCGF_CollagenI is an assay component measured in the BSK_hDFCGF assay. It measures Collagen I antibody related to regulation of gene protein expression using ELISA technology.", + "assayComponentTargetDesc": "Collagen I is involved in tissue remodeling and fibrosis, and is the most common fibrillar collagen that is found in skin, bone, tendons and other connective tissues. Collagen I is categorized as a tissue remodeling-related activity in the HDF3CGF system modeling Th1 inflammation involved in wound healing and matrix remodeling of the skin.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene protein expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Collagen I antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 2452, + "geneName": "collagen type I alpha 1 chain", + "description": null, + "geneSymbol": "COL1A1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 1277, + "officialSymbol": "COL1A1", + "officialFullName": "collagen type I alpha 1 chain", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2899, + "assayComponentEndpointName": "BSK_hDFCGF_ITAC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_ITAC was analyzed at the endpoint, BSK_hDFCGF_ITAC, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'chemotactic factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2744, + "assayComponentName": "BSK_hDFCGF_ITAC", + "assayComponentDesc": "BSK_hDFCGF_ITAC is an assay component measured in the BSK_hDFCGF assay. It measures I-TAC antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Interferon inducible T Cell Alpha Chemoattractant (I-TAC/CXCL11) is a chemokine that mediates T cell and monocyte chemotaxis. I-TAC is categorized as an inflammation-related activity in the HDF3CGF system modeling Th1 inflammation involved in wound healing and matrix remodeling of the skin", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "I-TAC antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 6313, + "geneName": "C-X-C motif chemokine ligand 11", + "description": null, + "geneSymbol": "CXCL11", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 6373, + "officialSymbol": "CXCL11", + "officialFullName": "C-X-C motif chemokine ligand 11", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2901, + "assayComponentEndpointName": "BSK_hDFCGF_TIMP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_TIMP2 was analyzed at the endpoint, BSK_hDFCGF_TIMP2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'protease' intended target family, where the subfamily is 'matrix metalloproteinase'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2745, + "assayComponentName": "BSK_hDFCGF_TIMP2", + "assayComponentDesc": "BSK_hDFCGF_TIMP2 is an assay component measured in the BSK_hDFCGF assay. It measures TIMP-2 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "TIMP-2 is a tissue inhibitor of matrix metalloproteases and is involved in tissue remodeling, angiogenesis and fibrosis. TIMP-2 is categorized as a tissue remodeling-related activity in the HDF3CGF system modeling Th1 inflammation involved in wound healing and matrix remodeling of the skin.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TIMP-2 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 325, + "geneName": "TIMP metallopeptidase inhibitor 2", + "description": null, + "geneSymbol": "TIMP2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7077, + "officialSymbol": "TIMP2", + "officialFullName": "TIMP metallopeptidase inhibitor 2", + "uniprotAccessionNumber": "Q96MC4" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2903, + "assayComponentEndpointName": "BSK_KF3CT_IL8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_KF3CT_IL8 was analyzed at the endpoint, BSK_KF3CT_IL8, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'interleukins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2746, + "assayComponentName": "BSK_KF3CT_IL8", + "assayComponentDesc": "BSK_KF3CT_IL8 is an assay component measured in the BSK_KF3CT assay. It measures IL-8 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Interleukin 8 (IL-8/CXCL8) is a chemokine that mediates neutrophil recruitment into acute inflammatory sites. IL-8 is categorized as an inflammation-related activity in the KF3CT system modeling Th1 cutaneous inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-8 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 12, + "assayName": "BSK_KF3CT", + "assayDesc": "BSK_KF3CT is a cell-based, multiplexed-readout assay that uses keratinocytes and foreskin fibroblasts, a human skin primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "keratinocytes and foreskin fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 177, + "geneName": "chemokine (C-X-C motif) ligand 8", + "description": null, + "geneSymbol": "CXCL8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3576, + "officialSymbol": "CXCL8", + "officialFullName": "chemokine (C-X-C motif) ligand 8", + "uniprotAccessionNumber": "P10145" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2905, + "assayComponentEndpointName": "BSK_KF3CT_MIG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_KF3CT_MIG was analyzed at the endpoint, BSK_KF3CT_MIG, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'chemotactic factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2747, + "assayComponentName": "BSK_KF3CT_MIG", + "assayComponentDesc": "BSK_KF3CT_MIG is an assay component measured in the BSK_KF3CT assay. It measures MIG antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Monokine induced by gamma interferon (MIG/CXCL9) is a chemokine that mediates T cell recruitment. MIG is categorized as an inflammation-related activity in the KF3CT system modeling Th1 cutaneous inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MIG antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 12, + "assayName": "BSK_KF3CT", + "assayDesc": "BSK_KF3CT is a cell-based, multiplexed-readout assay that uses keratinocytes and foreskin fibroblasts, a human skin primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "keratinocytes and foreskin fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 201, + "geneName": "chemokine (C-X-C motif) ligand 9", + "description": null, + "geneSymbol": "CXCL9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4283, + "officialSymbol": "CXCL9", + "officialFullName": "chemokine (C-X-C motif) ligand 9", + "uniprotAccessionNumber": "Q07325" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2907, + "assayComponentEndpointName": "BSK_KF3CT_PAI1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_KF3CT_PAI1 was analyzed at the endpoint, BSK_KF3CT_PAI1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'plasmogen activator inhibitor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "plasmogen activator inhibitor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2748, + "assayComponentName": "BSK_KF3CT_PAI1", + "assayComponentDesc": "BSK_KF3CT_PAI1 is an assay component measured in the BSK_KF3CT assay. It measures PAI-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Plasminogen activator inhibitor-1 (PAI-I) is a serine proteinase inhibitor and inhibitor of tissue plasminogen activator (tPA) and urokinase (uPA) and is involved in tissue remodeling and fibrinolysis. PAI-I is categorized as a tissue remodeling-related activity in the KF3CT system modeling Th1 cutaneous inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "PAI-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 12, + "assayName": "BSK_KF3CT", + "assayDesc": "BSK_KF3CT is a cell-based, multiplexed-readout assay that uses keratinocytes and foreskin fibroblasts, a human skin primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "keratinocytes and foreskin fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 229, + "geneName": "serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1", + "description": null, + "geneSymbol": "SERPINE1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5054, + "officialSymbol": "SERPINE1", + "officialFullName": "serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1", + "uniprotAccessionNumber": "P05121" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2909, + "assayComponentEndpointName": "BSK_IMphg_MCP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_IMphg_MCP1 was analyzed at the endpoint, BSK_IMphg_MCP1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'chemotactic factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2749, + "assayComponentName": "BSK_IMphg_MCP1", + "assayComponentDesc": "BSK_IMphg_MCP1 is an assay component measured in the BSK_IMphg assay. It measures MCP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Monocyte chemoattractant protein-1 (MCP-1/CCL2) is a chemoattractant cytokine (chemokine) that regulates the recruitment of monocytes and T cells into sites of inflammation. MCP-1 is categorized as an inflammation-related activity in the lMphg system modeling macrophage-driven Th1 vascular inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MCP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 856, + "assayName": "BSK_IMphg", + "assayDesc": "BSK_IMphg is a cell-based, multiplexed-readout assay that uses venular endothelial cells and macrophages, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "venular endothelial cells and macrophages", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 291, + "geneName": "chemokine (C-C motif) ligand 2", + "description": null, + "geneSymbol": "CCL2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6347, + "officialSymbol": "CCL2", + "officialFullName": "chemokine (C-C motif) ligand 2", + "uniprotAccessionNumber": "P13500" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2911, + "assayComponentEndpointName": "BSK_IMphg_MIP1a", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_IMphg_MIP1a was analyzed at the endpoint, BSK_IMphg_MIP1a, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'inflammatory factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "inflammatory factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2750, + "assayComponentName": "BSK_IMphg_MIP1a", + "assayComponentDesc": "BSK_IMphg_MIP1a is an assay component measured in the BSK_IMphg assay. It measures MIP-1a antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Macrophage inflammatory protein 1 alpha (MIP-1a/CCL3) is a pro-inflammatory chemokine that mediates leukocyte recruitment to sites of inflammation. MIP-1a is categorized as an inflammation-related activity in the lMphg system modeling macrophage-driven Th1 vascular inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MIP-1a antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 856, + "assayName": "BSK_IMphg", + "assayDesc": "BSK_IMphg is a cell-based, multiplexed-readout assay that uses venular endothelial cells and macrophages, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "venular endothelial cells and macrophages", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 6291, + "geneName": "C-C motif chemokine ligand 3", + "description": null, + "geneSymbol": "CCL3", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 6348, + "officialSymbol": "CCL3", + "officialFullName": "C-C motif chemokine ligand 3", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2913, + "assayComponentEndpointName": "BSK_IMphg_VCAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_IMphg_VCAM1 was analyzed at the endpoint, BSK_IMphg_VCAM1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'Immunoglobulin CAM'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2751, + "assayComponentName": "BSK_IMphg_VCAM1", + "assayComponentDesc": "BSK_IMphg_VCAM1 is an assay component measured in the BSK_IMphg assay. It measures VCAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Vascular Cell Adhesion Molecule 1 (VCAM-1/CD106) is a cell adhesion molecule that mediates adhesion of monocytes and T cells to endothelial cells. VCAM-1 is categorized as an inflammation-related activity in the lMphg system modeling macrophage-driven Th1 vascular inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "VCAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 856, + "assayName": "BSK_IMphg", + "assayDesc": "BSK_IMphg is a cell-based, multiplexed-readout assay that uses venular endothelial cells and macrophages, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "venular endothelial cells and macrophages", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 334, + "geneName": "vascular cell adhesion molecule 1", + "description": null, + "geneSymbol": "VCAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7412, + "officialSymbol": "VCAM1", + "officialFullName": "vascular cell adhesion molecule 1", + "uniprotAccessionNumber": "P19320" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2915, + "assayComponentEndpointName": "BSK_IMphg_CD40", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_IMphg_CD40 was analyzed at the endpoint, BSK_IMphg_CD40, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'inflammatory factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "inflammatory factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2752, + "assayComponentName": "BSK_IMphg_CD40", + "assayComponentDesc": "BSK_IMphg_CD40 is an assay component measured in the BSK_IMphg assay. It measures CD40 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "CD40 is a cell surface adhesion receptor and costimulatory receptor for T cell activation that is expressed on antigen presenting cells, endothelial cells, smooth muscle cells, fibroblasts and epithelial cells. CD40 is categorized as an immunomodulatory-related activity in the lMphg system modeling macrophage-driven Th1 vascular inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD40 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 856, + "assayName": "BSK_IMphg", + "assayDesc": "BSK_IMphg is a cell-based, multiplexed-readout assay that uses venular endothelial cells and macrophages, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "venular endothelial cells and macrophages", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 49, + "geneName": "CD40 molecule, TNF receptor superfamily member 5", + "description": null, + "geneSymbol": "CD40", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 958, + "officialSymbol": "CD40", + "officialFullName": "CD40 molecule, TNF receptor superfamily member 5", + "uniprotAccessionNumber": "P25942" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2917, + "assayComponentEndpointName": "BSK_IMphg_ESelectin", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_IMphg_ESelectin was analyzed at the endpoint, BSK_IMphg_ESelectin, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell adhesion molecules' intended target family, where the subfamily is 'selectins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "selectins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2753, + "assayComponentName": "BSK_IMphg_ESelectin", + "assayComponentDesc": "BSK_IMphg_ESelectin is an assay component measured in the BSK_IMphg assay. It measures E-selectin antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "E-Selectin/CD62E is a cell adhesion molecule expressed only on endothelial cells that mediates leukocyte-endothelial cell interactions. E-Selectin is categorized as an inflammation-related activity in the lMphg system modeling macrophage-driven Th1 vascular inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "E-selectin antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 856, + "assayName": "BSK_IMphg", + "assayDesc": "BSK_IMphg is a cell-based, multiplexed-readout assay that uses venular endothelial cells and macrophages, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "venular endothelial cells and macrophages", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 293, + "geneName": "selectin E", + "description": null, + "geneSymbol": "SELE", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6401, + "officialSymbol": "SELE", + "officialFullName": "selectin E", + "uniprotAccessionNumber": "P16581" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2919, + "assayComponentEndpointName": "BSK_IMphg_CD69", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_IMphg_CD69 was analyzed at the endpoint, BSK_IMphg_CD69, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'inflammatory factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "inflammatory factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2754, + "assayComponentName": "BSK_IMphg_CD69", + "assayComponentDesc": "BSK_IMphg_CD69 is an assay component measured in the BSK_IMphg assay. It measures CD69 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "CD69 is a cell surface activation antigen that is induced early during immune activation and is involved in macrophage activation. CD69 is categorized as an immunomodulatory-related activity in the lMphg system modeling macrophage-driven Th1 vascular inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD69 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 856, + "assayName": "BSK_IMphg", + "assayDesc": "BSK_IMphg is a cell-based, multiplexed-readout assay that uses venular endothelial cells and macrophages, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "venular endothelial cells and macrophages", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 50, + "geneName": "CD69 molecule", + "description": null, + "geneSymbol": "CD69", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 969, + "officialSymbol": "CD69", + "officialFullName": "CD69 molecule", + "uniprotAccessionNumber": "Q07108" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2921, + "assayComponentEndpointName": "BSK_IMphg_IL8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_IMphg_IL8 was analyzed at the endpoint, BSK_IMphg_IL8, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'interleukins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2755, + "assayComponentName": "BSK_IMphg_IL8", + "assayComponentDesc": "BSK_IMphg_IL8 is an assay component measured in the BSK_IMphg assay. It measures IL-8 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Interleukin 8 (IL-8/CXCL8) is a chemokine that mediates neutrophil recruitment into acute inflammatory sites. IL-8 is categorized as an inflammation-related activity in the lMphg system modeling macrophage-driven Th1 vascular inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-8 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 856, + "assayName": "BSK_IMphg", + "assayDesc": "BSK_IMphg is a cell-based, multiplexed-readout assay that uses venular endothelial cells and macrophages, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "venular endothelial cells and macrophages", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 177, + "geneName": "chemokine (C-X-C motif) ligand 8", + "description": null, + "geneSymbol": "CXCL8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3576, + "officialSymbol": "CXCL8", + "officialFullName": "chemokine (C-X-C motif) ligand 8", + "uniprotAccessionNumber": "P10145" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2923, + "assayComponentEndpointName": "BSK_IMphg_IL1a", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_IMphg_IL1a was analyzed at the endpoint, BSK_IMphg_IL1a, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'interleukins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2756, + "assayComponentName": "BSK_IMphg_IL1a", + "assayComponentDesc": "BSK_IMphg_IL1a is an assay component measured in the BSK_IMphg assay. It measures IL-1a antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Interleukin 1alpha (IL-1a) is a secreted proinflammatory cytokine involved in endothelial cell activation and neutrophil recruitment. Secreted IL-1a (sIL-1a) is categorized as an inflammation-related activity in the lMphg system modeling macrophage-driven Th1 vascular inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-1a antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 856, + "assayName": "BSK_IMphg", + "assayDesc": "BSK_IMphg is a cell-based, multiplexed-readout assay that uses venular endothelial cells and macrophages, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "venular endothelial cells and macrophages", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 174, + "geneName": "interleukin 1, alpha", + "description": null, + "geneSymbol": "IL1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3552, + "officialSymbol": "IL1A", + "officialFullName": "interleukin 1, alpha", + "uniprotAccessionNumber": "P01583" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2925, + "assayComponentEndpointName": "BSK_IMphg_MCSF", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_IMphg_MCSF was analyzed at the endpoint, BSK_IMphg_MCSF, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'colony stimulating factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "colony stimulating factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2757, + "assayComponentName": "BSK_IMphg_MCSF", + "assayComponentDesc": "BSK_IMphg_MCSF is an assay component measured in the BSK_IMphg assay. It measures M-CSF antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Macrophage colony-stimulating factor (M-CSF) is a secreted and cell surface cytokine that mediates macrophage differentiation. M-CSF is categorized as an immunomodulatory-related activity in the lMphg system modeling macrophage-driven Th1 vascular inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "M-CSF antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 856, + "assayName": "BSK_IMphg", + "assayDesc": "BSK_IMphg is a cell-based, multiplexed-readout assay that uses venular endothelial cells and macrophages, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "venular endothelial cells and macrophages", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 72, + "geneName": "colony stimulating factor 1 (macrophage)", + "description": null, + "geneSymbol": "CSF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1435, + "officialSymbol": "CSF1", + "officialFullName": "colony stimulating factor 1 (macrophage)", + "uniprotAccessionNumber": "P09603" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2927, + "assayComponentEndpointName": "BSK_IMphg_IL10", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_IMphg_IL10 was analyzed at the endpoint, BSK_IMphg_IL10, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'interleukins'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2758, + "assayComponentName": "BSK_IMphg_IL10", + "assayComponentDesc": "BSK_IMphg_IL10 is an assay component measured in the BSK_IMphg assay. It measures IL-10 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Interleukin 10 (IL-10) is a secreted anti-inflammatory cytokine. Secreted IL-10 (sIL-10) is categorized as an immunomodulatory-related activity in the lMphg system modeling macrophage-driven Th1 vascular inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-10 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 856, + "assayName": "BSK_IMphg", + "assayDesc": "BSK_IMphg is a cell-based, multiplexed-readout assay that uses venular endothelial cells and macrophages, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "venular endothelial cells and macrophages", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 4232, + "geneName": "interleukin 10", + "description": null, + "geneSymbol": "IL10", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 3586, + "officialSymbol": "IL10", + "officialFullName": "interleukin 10", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2929, + "assayComponentEndpointName": "BSK_IMphg_SRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_IMphg_SRB was analyzed at the endpoint, BSK_IMphg_SRB, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell morphology' intended target family, where the subfamily is 'cell conformation'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2759, + "assayComponentName": "BSK_IMphg_SRB", + "assayComponentDesc": "BSK_IMphg_SRB is an assay component measured in the BSK_IMphg assay. It measures 0.1% sulforhodamine related to cell death using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "SRB in the lMphg system is a measure of the total protein content of venular endothelial cells and macrophages. Cell viability of adherent cells is measured by Sulforhodamine B (SRB) staining, a method that determines cell density by measuring total protein content of test wells.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 856, + "assayName": "BSK_IMphg", + "assayDesc": "BSK_IMphg is a cell-based, multiplexed-readout assay that uses venular endothelial cells and macrophages, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "venular endothelial cells and macrophages", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2931, + "assayComponentEndpointName": "BSK_IMphg_SRB.Mphg", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_IMphg_SRB.Mphg was analyzed at the endpoint, BSK_IMphg_SRB.Mphg, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cell morphology' intended target family, where the subfamily is 'cell conformation'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2760, + "assayComponentName": "BSK_IMphg_SRB.Mphg", + "assayComponentDesc": "BSK_IMphg_SRB.Mphg is an assay component measured in the BSK_IMphg assay. It measures 0.1% sulforhodamine related to cell death using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "SRB-Mphg in the lMphg system is a measure of the total protein content of macrophages alone. Cell viability of adherent cells is measured by Sulforhodamine B (SRB) staining, a method that determines cell density by measuring total protein content of test wells.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 856, + "assayName": "BSK_IMphg", + "assayDesc": "BSK_IMphg is a cell-based, multiplexed-readout assay that uses venular endothelial cells and macrophages, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "venular endothelial cells and macrophages", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.3389/fdata.2019.00047", + "url": "https://pubmed.ncbi.nlm.nih.gov/33693370/", + "pmid": 33693370, + "title": "Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition", + "author": "Berg EL", + "citation": "Berg EL. Human Cell-Based in vitro Phenotypic Profiling for Drug Safety-Related Attrition. Front Big Data. 2019 Dec 11;2:47. doi: 10.3389/fdata.2019.00047. PMID: 33693370; PMCID: PMC7931891.", + "otherId": "0", + "citationId": 287, + "otherSource": "" + } + }, + { + "aeid": 2933, + "assayComponentEndpointName": "BSK_LPS_Thrombomodulin", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_Thrombodulin was analyzed at the endpoint, BSK_LPS_Thrombomodulin, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'gpcr' intended target family, where the subfamily is 'rhodopsin-like receptor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2761, + "assayComponentName": "BSK_LPS_Thrombomodulin", + "assayComponentDesc": "BSK_LPS_Thrombomodulin is an assay component measured in the BSK_LPS assay. It measures Thrombomodulin antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Thrombomodulin/CD141 is a cell surface receptor for complement factor 3b with anti-coagulant, anti-inflammatory and cytoprotective activities during the process of fibrinolysis, coagulation and thrombosis. Thrombomodulin is categorized as a hemostasis-related activity in the LPS system modeling monocyte-driven Th1 vascular inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Thrombomodulin antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 320, + "geneName": "thrombomodulin", + "description": null, + "geneSymbol": "THBD", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7056, + "officialSymbol": "THBD", + "officialFullName": "thrombomodulin", + "uniprotAccessionNumber": "P07204" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2935, + "assayComponentEndpointName": "BSK_LPS_CD69", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_CD69 was analyzed at the endpoint, BSK_LPS_CD69, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand protein changes. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'cytokine' intended target family, where the subfamily is 'inflammatory factor'.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "inflammatory factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2762, + "assayComponentName": "BSK_LPS_CD69", + "assayComponentDesc": "BSK_LPS_CD69 is an assay component measured in the BSK_LPS assay. It measures CD69 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "CD69 is a cell surface activation antigen. CD69 is categorized as an immunomodulatory-related activity in the LPS system modeling monocyte-driven Th1 vascular inflammation.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD69 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 50, + "geneName": "CD69 molecule", + "description": null, + "geneSymbol": "CD69", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 969, + "officialSymbol": "CD69", + "officialFullName": "CD69 molecule", + "uniprotAccessionNumber": "Q07108" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2938, + "assayComponentEndpointName": "IUF_NPC2a_radial_glia_migration_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC2a_radial_glia_migration_72hr component was analyzed at the endpoint IUF_NPC2a_radial_glia_migration_72hr in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of migration reporter, gain or loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "SRC kinase inhibitor PP2", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural progenitor cell migration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2763, + "assayComponentName": "IUF_NPC2a_radial_glia_migration_72hr", + "assayComponentDesc": "IUF_NPC2a_radial glia_migration_72hr is one of 12 assay components measured from the IUF_NPC2-5 assay. The migration distance of radial glia at 72 hr is assessed in µm from the edge of the sphere core to the edge of the migration area based on brightfield images of each well. Therefore, each plate is scanned using a high content imaging device. Images are exported and the migration distance is measured manually in four directions using ImageJ. The mean of four measures per well is used as raw data input.", + "assayComponentTargetDesc": "Changes in the migration distance of radial glia are indicative of radial glia migration during neurodevelopment.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "migration reporter", + "assayDesignTypeSub": "radial glia migration", + "biologicalProcessTarget": "migration during neurodevelopment", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "migration distance", + "detectionTechnology": "Automated phase contrast imaging ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "migration distance of radial glia at 72hr", + "aid": 858, + "assayName": "IUF_NPC2-5", + "assayDesc": "IUF_NPC2-5 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 or 120 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. In the neural progenitor cell migration and differentiation assay (NPC2-5), hNPC’s grown as spheres are plated on an extracellular matrix and migrate and differentiate out of the sphere core. The processes radial glia migration, neuronal and oligodendrocyte migration as well as neuronal differentiation, neuronal morphology and oligodendrocyte differentiation are studied using automated phase contrast imaging and automated fluorescence imaging in combination with high content image analysis. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2940, + "assayComponentEndpointName": "IUF_NPC2a_radial_glia_migration_120hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC2a_radial_glia_migration_120hr component was analyzed at the endpoint IUF_NPC2a_ radial_glia_migration_120hr in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of migration reporter, gain or loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural progenitor cell migration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2764, + "assayComponentName": "IUF_NPC2a_radial_glia_migration_120hr", + "assayComponentDesc": "IUF_NPC2a_radial_glia_migration_120hr is one of 12 assay components measured from the IUF_NPC2-5 assay. The migration distance of radial glia at 120 hr is assessed in µm from the edge of the sphere core to the edge of the migration area based on fluorescent images of Hoechst-positive nuclei. With the identification of each nucleus position around the sphere core, migration-related parameters can be calculated. First, a nuclei density distribution is calculated for which an algorithm determines relatively more and less dense nuclei areas. This calculation identifies the sphere core by the densest nuclei area in the image. The algorithm further assumes that nuclei density decreases from the sphere core to the periphery. When the nuclei density hits a pre-defined threshold, the outer boundaries of the migration area are determined and the sphere itself is mapped out in a polynomial bounding box. Derived from this box, the size of the migration area and the migration distance are calculated for each well.", + "assayComponentTargetDesc": "Changes in the migration distance of radial glia are indicative of radial glia migration during neurodevelopment.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "migration reporter", + "assayDesignTypeSub": "radial glia migration", + "biologicalProcessTarget": "migration during neurodevelopment", + "detectionTechnologyType": "Fluorescence microscopy", + "detectionTechnologyTypeSub": "migration distance", + "detectionTechnology": "High content image analysis", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst 33342 dye", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "migration distance of radial glia at 120hr", + "aid": 858, + "assayName": "IUF_NPC2-5", + "assayDesc": "IUF_NPC2-5 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 or 120 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. In the neural progenitor cell migration and differentiation assay (NPC2-5), hNPC’s grown as spheres are plated on an extracellular matrix and migrate and differentiate out of the sphere core. The processes radial glia migration, neuronal and oligodendrocyte migration as well as neuronal differentiation, neuronal morphology and oligodendrocyte differentiation are studied using automated phase contrast imaging and automated fluorescence imaging in combination with high content image analysis. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2942, + "assayComponentEndpointName": "IUF_NPC2b_neuronal_migration_120hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC2b_neuronal_migration_120hr component was analyzed at the endpoint IUF_NPC2b_neuronal_migration_120hr in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of migration reporter, gain or loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural progenitor cell migration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2765, + "assayComponentName": "IUF_NPC2b_neuronal_migration_120hr", + "assayComponentDesc": "IUF_NPC2b_neuronal_migration_120hr is one of 12 assay components measured from the IUF_NPC2-5 assay. Neuronal migration distance at 120 hr is the mean distance of all neurons from the edge of the sphere core to each individual neuron (see IUF_NPC3_neuronal_differentiation_120hr). Neuronal migration is normalized to radial glia migration distance at 120 hr.", + "assayComponentTargetDesc": "Changes in the migration distance of neurons are indicative of neurodevelopment.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "migration reporter", + "assayDesignTypeSub": "neuronal migration", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence microscopy", + "detectionTechnologyTypeSub": "migration distance", + "detectionTechnology": "High content image analysis", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "migration distance of neurons at 120hr", + "aid": 858, + "assayName": "IUF_NPC2-5", + "assayDesc": "IUF_NPC2-5 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 or 120 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. In the neural progenitor cell migration and differentiation assay (NPC2-5), hNPC’s grown as spheres are plated on an extracellular matrix and migrate and differentiate out of the sphere core. The processes radial glia migration, neuronal and oligodendrocyte migration as well as neuronal differentiation, neuronal morphology and oligodendrocyte differentiation are studied using automated phase contrast imaging and automated fluorescence imaging in combination with high content image analysis. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2944, + "assayComponentEndpointName": "IUF_NPC2c_oligodendrocyte_migration_120hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC2c_oligodendrocyte_migration_120hr component was analyzed at the endpoint IUF_NPC2c_oligodendrocyte_migration_120hr in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of migration reporter, gain or loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural progenitor cell migration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2766, + "assayComponentName": "IUF_NPC2c_oligodendrocyte_migration_120hr", + "assayComponentDesc": "IUF_NPC2b_oligodendrocyte_migration_120hr is one of 12 assay components measured from the IUF_NPC2-5 assay. Oligodendrocyte migration distance at 120 hr is the mean distance of all oligodendrocytes from the edge of the sphere core to each individual oligodendrocyte (see IUF_NPC5_oligodendrocyte_differentiation_120hr). Oligodendrocyte migration is normalized to radial glia migration distance at 120 hr.", + "assayComponentTargetDesc": "Changes in the migration distance of oligodendrocytes are indicative of neurodevelopment.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "migration reporter", + "assayDesignTypeSub": "oligodendrocyte migration", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence microscopy", + "detectionTechnologyTypeSub": "migration distance", + "detectionTechnology": "High content image analysis", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "O4 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "migration distance of oligodendrocytes at 120hr", + "aid": 858, + "assayName": "IUF_NPC2-5", + "assayDesc": "IUF_NPC2-5 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 or 120 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. In the neural progenitor cell migration and differentiation assay (NPC2-5), hNPC’s grown as spheres are plated on an extracellular matrix and migrate and differentiate out of the sphere core. The processes radial glia migration, neuronal and oligodendrocyte migration as well as neuronal differentiation, neuronal morphology and oligodendrocyte differentiation are studied using automated phase contrast imaging and automated fluorescence imaging in combination with high content image analysis. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2946, + "assayComponentEndpointName": "IUF_NPC3_neuronal_differentiation_120hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC3_neuronal_differentiation_120hr component was analyzed at the endpoint IUF_NPC3_neuronal_differentiation_120hr in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of differentiation reporter, gain or loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "EGF", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural progenitor differentiation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2767, + "assayComponentName": "IUF_NPC3_neuronal_differentiation_120hr", + "assayComponentDesc": "IUF_NPC3_neuronal_differentiation_120hr is one of 12 assay components measured from the IUF_NPC2-5 assay. Neuronal differentiation is determined as the number of all TUBB3 positive cells in percent of the number of Hoechst-positive nuclei in the total neurosphere migration area (see IUF_NPC2a_ glia_migration_120hr) after 120 hr of migration/differentiation. Neurons are automatically identified using a convolutional neural network (CNN) that was trained using manually annotated images of differentiated neurons. ", + "assayComponentTargetDesc": "Changes in the neuronal differentiation are indicative of neurodevelopment.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "differentiation reporter", + "assayDesignTypeSub": "neuronal differentiation", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence microscopy", + "detectionTechnologyTypeSub": "cell identification", + "detectionTechnology": "High content image analysis", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "neuronal differentiation at 120 hr", + "aid": 858, + "assayName": "IUF_NPC2-5", + "assayDesc": "IUF_NPC2-5 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 or 120 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. In the neural progenitor cell migration and differentiation assay (NPC2-5), hNPC’s grown as spheres are plated on an extracellular matrix and migrate and differentiate out of the sphere core. The processes radial glia migration, neuronal and oligodendrocyte migration as well as neuronal differentiation, neuronal morphology and oligodendrocyte differentiation are studied using automated phase contrast imaging and automated fluorescence imaging in combination with high content image analysis. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2948, + "assayComponentEndpointName": "IUF_NPC4_neurite_length_120hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC4_neurite_length_120hr component was analyzed at the endpoint IUF_NPC4_neurite_length_120hr in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of differentiation reporter, gain or loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural progenitor differentiation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2768, + "assayComponentName": "IUF_NPC4_neurite_length_120hr", + "assayComponentDesc": "IUF_NPC4_neurite_length_120hr is one of 12 assay components measured from the IUF_NPC2-5 assay. The neurite length at 120 hr is the mean length in um of all neurons (see IUF_NPC3_neuronal_differentiation_120hr) that are identified by the skeletonization algorithm in Omnisphero.", + "assayComponentTargetDesc": "Changes in the neurite length are indicative of neurodevelopment.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "differentiation reporter", + "assayDesignTypeSub": "neuronal morphology", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence microscopy", + "detectionTechnologyTypeSub": "morphology", + "detectionTechnology": "High content image analysis", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "neurite length at 120hr", + "aid": 858, + "assayName": "IUF_NPC2-5", + "assayDesc": "IUF_NPC2-5 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 or 120 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. In the neural progenitor cell migration and differentiation assay (NPC2-5), hNPC’s grown as spheres are plated on an extracellular matrix and migrate and differentiate out of the sphere core. The processes radial glia migration, neuronal and oligodendrocyte migration as well as neuronal differentiation, neuronal morphology and oligodendrocyte differentiation are studied using automated phase contrast imaging and automated fluorescence imaging in combination with high content image analysis. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2950, + "assayComponentEndpointName": "IUF_NPC4_neurite_area_120hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC4_neurite_area_120hr component was analyzed at the endpoint IUF_NPC4_neurite_area_120hr in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of differentiation reporter, loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural progenitor differentiation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2769, + "assayComponentName": "IUF_NPC4_neurite_area_120hr", + "assayComponentDesc": "IUF_NPC4_neurite_area_120hr is one of 12 assay components measured from the IUF_NPC2-5 assay. The neurite area at 120 hr is the mean area in pixel (without nuclei) of all neurons (see IUF_NPC3_neuronal_differentiation_120hr) that are identified by the skeletonization algorithm in Omnisphero.", + "assayComponentTargetDesc": "Changes in the neurite area are indicative of neurodevelopment.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "differentiation reporter", + "assayDesignTypeSub": "neuronal morphology", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence microscopy", + "detectionTechnologyTypeSub": "morphology", + "detectionTechnology": "High content image analysis", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "neurite area at 120hr", + "aid": 858, + "assayName": "IUF_NPC2-5", + "assayDesc": "IUF_NPC2-5 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 or 120 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. In the neural progenitor cell migration and differentiation assay (NPC2-5), hNPC’s grown as spheres are plated on an extracellular matrix and migrate and differentiate out of the sphere core. The processes radial glia migration, neuronal and oligodendrocyte migration as well as neuronal differentiation, neuronal morphology and oligodendrocyte differentiation are studied using automated phase contrast imaging and automated fluorescence imaging in combination with high content image analysis. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2952, + "assayComponentEndpointName": "IUF_NPC5_oligodendrocyte_differentiation_120hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC5_oligodendrocyte_differentiation_120hr component was analyzed at the endpoint IUF_NPC5_oligodendrocyte_differentiation_120hr in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of differentiation reporter, loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "BMP7", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural progenitor differentiation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2770, + "assayComponentName": "IUF_NPC5_oligodendrocyte_differentiation_120hr", + "assayComponentDesc": "IUF_NPC5_oligodendrocyte_differentiation_120hr is one of 12 assay components measured from the IUF_NPC2-5 assay. Oligodendrocyte differentiation at 120 hr is determined as the number of all O4-positive cells in percent of the number of Hoechst-positive nuclei in the total neurosphere migration area (see IUF_NPC2a_ glia_migration_120hr) after 120 hr of migration/differentiation. Oligodendrocytes are automatically identified using a convolutional neural network (CNN) that was trained using manually annotated images of differentiated oligodendrocytes.", + "assayComponentTargetDesc": "Changes in the oligodendrocyte differentiation are indicative of neurodevelopment.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "differentiation reporter", + "assayDesignTypeSub": "oligodendrocyte differentiation", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence microscopy", + "detectionTechnologyTypeSub": "cell identification", + "detectionTechnology": "High content image analysis", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "O4 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "oligodendrocyte differentiation at 120hr", + "aid": 858, + "assayName": "IUF_NPC2-5", + "assayDesc": "IUF_NPC2-5 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 or 120 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. In the neural progenitor cell migration and differentiation assay (NPC2-5), hNPC’s grown as spheres are plated on an extracellular matrix and migrate and differentiate out of the sphere core. The processes radial glia migration, neuronal and oligodendrocyte migration as well as neuronal differentiation, neuronal morphology and oligodendrocyte differentiation are studied using automated phase contrast imaging and automated fluorescence imaging in combination with high content image analysis. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2954, + "assayComponentEndpointName": "IUF_NPC2-5_cytotoxicity_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC2-5_cytotoxicity_72hr component was analyzed at the endpoint IUF_NPC2-5_cytotoxicity_72hr in the positive analysis fitting direction relative to the dynamic range and baseline of activity. Using a type of viability reporter, gain-of-signal activity can be used to understand cytotoxicity effects.", + "assayFunctionType": "cytotoxicity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "lysed cells", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "enzyme activity", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2771, + "assayComponentName": "IUF_NPC2-5_cytotoxicity_72hr", + "assayComponentDesc": "IUF_NPC2-5_cytotoxicity_72hr is one of 12 assay components measured from the IUF_NPC2-5 assay. It is designed to measure the cytotoxicity at 72 hr as assessed by membrane integrity related to the LDH dependent reduction of resazurin to resorufin in the supernatant of each well. The cytotoxicity is measured as fluorescence signal (relative fluorescence unit) in a multiplate reader. ", + "assayComponentTargetDesc": "Changes in enzymatic activity (increase in lactate dehydrogenase) are indicative of compromised cell health. Reductions in the total LDH (in cells), indicates cell loss or death.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "cytotoxicity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "membrane integrity assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "resazurin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme: lactate dehydrogenase", + "aid": 858, + "assayName": "IUF_NPC2-5", + "assayDesc": "IUF_NPC2-5 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 or 120 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. In the neural progenitor cell migration and differentiation assay (NPC2-5), hNPC’s grown as spheres are plated on an extracellular matrix and migrate and differentiate out of the sphere core. The processes radial glia migration, neuronal and oligodendrocyte migration as well as neuronal differentiation, neuronal morphology and oligodendrocyte differentiation are studied using automated phase contrast imaging and automated fluorescence imaging in combination with high content image analysis. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2956, + "assayComponentEndpointName": "IUF_NPC2-5_cytotoxicity_120hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC2-5_cytotoxicity_120hr component was analyzed at the endpoint IUF_NPC2-5_cytotoxicity_120hr in the positive analysis fitting direction relative to the dynamic range and baseline of activity. Using a type of viability reporter, gain-of-signal activity can be used to understand cytotoxicity effects.", + "assayFunctionType": "cytotoxicity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "lysed cells", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "enzyme activity", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2772, + "assayComponentName": "IUF_NPC2-5_cytotoxicity_120hr", + "assayComponentDesc": "IUF_NPC2-5_cytotoxicity_120hr is one of 12 assay components measured from the IUF_NPC2-5 assay. It is designed to measure cytotoxicity at 120hr due to loss of membrane integrity. LDH measurements are performed from medium supernatants of each well and are based on the reduction of resazurin to resorufin measured as fluorescence signal (relative fluorescence unit) in a multiplate reader. ", + "assayComponentTargetDesc": "Changes in enzymatic activity (increase in lactate dehydrogenase) are indicative of compromised cell health. Reductions in the total LDH (in cells), indicates cell loss or death.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "cytotoxicity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "membrane integrity assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "resazurin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme: lactate dehydrogenase", + "aid": 858, + "assayName": "IUF_NPC2-5", + "assayDesc": "IUF_NPC2-5 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 or 120 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. In the neural progenitor cell migration and differentiation assay (NPC2-5), hNPC’s grown as spheres are plated on an extracellular matrix and migrate and differentiate out of the sphere core. The processes radial glia migration, neuronal and oligodendrocyte migration as well as neuronal differentiation, neuronal morphology and oligodendrocyte differentiation are studied using automated phase contrast imaging and automated fluorescence imaging in combination with high content image analysis. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2958, + "assayComponentEndpointName": "IUF_NPC2-5_cell_number_120hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC2-5_cell_number_120hr component was analyzed at the endpoint IUF_NPC2-5_cell_number_120hr in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain or loss-of-signal activity can be used to understand viability effects.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "EGF", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cell count", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "viability", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2773, + "assayComponentName": "IUF_NPC2-5_cell_number_120hr", + "assayComponentDesc": "IUF_NPC2-5_cell number_120hr is one of 12 assay components measured from the IUF_NPC2-5 assay. The cell number at 120 hr is assessed as the number of all Hoechst-positive nuclei identified in the migration area (see IUF_NPC2a_ glia_migration_120hr).", + "assayComponentTargetDesc": "Changes in the number of Hoechst labelled nuclei are indicative of cell proliferation.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell number", + "biologicalProcessTarget": "cell viability", + "detectionTechnologyType": "Fluorescence microscopy", + "detectionTechnologyTypeSub": "cell identification", + "detectionTechnology": "membrane integrity assay", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst 33342 dye", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of Hoechst labelled nuclei", + "aid": 858, + "assayName": "IUF_NPC2-5", + "assayDesc": "IUF_NPC2-5 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 or 120 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. In the neural progenitor cell migration and differentiation assay (NPC2-5), hNPC’s grown as spheres are plated on an extracellular matrix and migrate and differentiate out of the sphere core. The processes radial glia migration, neuronal and oligodendrocyte migration as well as neuronal differentiation, neuronal morphology and oligodendrocyte differentiation are studied using automated phase contrast imaging and automated fluorescence imaging in combination with high content image analysis. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 2960, + "assayComponentEndpointName": "IUF-NPC2-5_viability_120hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC2-5_viability_120hr component was analyzed at the endpoint IUF-NPC2-5_viability_120hr in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain or loss-of-signal activity can be used to understand viability effects.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "lysed cells", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "viability", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2774, + "assayComponentName": "IUF-NPC2-5_viability_120hr", + "assayComponentDesc": "IUF_NPC2-5_viability_120hr is one of 12 assay components measured from the IUF_NPC2-5 assay. It is designed to measure cell viability assessed as mitochondria-dependent reduction of resazurin to resorufin using the alamar blue viability assay. The viability is measured as a fluorescence signal (relative fluorescence unit) in a multiplate reader. ", + "assayComponentTargetDesc": "Changes in enzymatic activity (mitochondrial activity) are correlated to cellular viability.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "cell viability", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Alamar blue viability assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "resazurin", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 858, + "assayName": "IUF_NPC2-5", + "assayDesc": "IUF_NPC2-5 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 or 120 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. In the neural progenitor cell migration and differentiation assay (NPC2-5), hNPC’s grown as spheres are plated on an extracellular matrix and migrate and differentiate out of the sphere core. The processes radial glia migration, neuronal and oligodendrocyte migration as well as neuronal differentiation, neuronal morphology and oligodendrocyte differentiation are studied using automated phase contrast imaging and automated fluorescence imaging in combination with high content image analysis. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 3019, + "assayComponentEndpointName": "VALA_TUBHUV_Agonist_CellCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_TUBHUV_Agonist_CellCount was analyzed at the endpoint, VALA_TUBHUV_Agonist_CellCount, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cell count.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cell count", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2805, + "assayComponentName": "VALA_TUBHUV_Agonist_CellCount", + "assayComponentDesc": "VALA_TUBHUV_Agonist_CellCount is the one of two assay components measured from the VALA_TUBHUV_Agonist assay. It is designed to make measurements of viability, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to the number of DAPI labelled nuceli is indicative of the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "DAPI", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "labelled nuclei", + "aid": 860, + "assayName": "VALA_TUBHUV_Agonist", + "assayDesc": "VALA_TUBHUV_Agonist is a cell-based, multiplexed assay that uses human umbilical vein endothelial cells (HUVEC). Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "umbilical vein-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HUVEC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3020, + "assayComponentEndpointName": "VALA_TUBHUV_Agonist_TubuleLength", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_TUBHUV_Agonist_TubuleLength was analyzed at the endpoint, VALA_TUBHUV_Agonist_TubuleLength, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, gain-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is tubulogenesis.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "suramin", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "morphology", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "tubulogenesis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2806, + "assayComponentName": "VALA_TUBHUV_Agonist_TubuleLength", + "assayComponentDesc": "VALA_TUBHUV_Agonist_TubuleLength is the one of two assay components measured from the VALA_TUBHUV_Agonist assay. It is designed to make measurements of tubulogenesis, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. This VALA_TUBHUV1 assay was designed to detect chemical activation of tubulogenesis, i.e. agonism.", + "assayComponentTargetDesc": "Vein growth supports angiogenesis, which is critical for development, maturation, and reproductive function. Dysregulation of angiogenesis can lead to birth defects, macular degeneration, impaired wound healing, and tumor growth. This assay measures compound effects on vein formation in basal medium, which lacks growth factors that support blood vessel growth. Tube formation agonists will increase vessel growth in these conditions.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "tubulogenesis", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD31 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mean tubule length", + "aid": 860, + "assayName": "VALA_TUBHUV_Agonist", + "assayDesc": "VALA_TUBHUV_Agonist is a cell-based, multiplexed assay that uses human umbilical vein endothelial cells (HUVEC). Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "umbilical vein-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HUVEC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3021, + "assayComponentEndpointName": "VALA_TUBHUV_Antagonist_CellCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_TUBHUV_Antagonist_CellCount was analyzed at the endpoint, VALA_TUBHUV_Antagonist_CellCount, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cell count.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cell count", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2807, + "assayComponentName": "VALA_TUBHUV_Antagonist_CellCount", + "assayComponentDesc": "VALA_TUBHUV_Antagonist_CellCount is the one of two assay components measured from the VALA_TUBHUV_Antagonist assay. It is designed to make measurements of viability, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to the number of DAPI labelled nuceli is indicative of the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "DAPI", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "labelled nuclei", + "aid": 861, + "assayName": "VALA_TUBHUV_Antagonist", + "assayDesc": "VALA_TUBHUV_Antagonist is a cell-based, multiplexed assay that uses human umbilical vein endothelial cells (HUVEC). Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "umbilical vein-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HUVEC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3022, + "assayComponentEndpointName": "VALA_TUBHUV_Antagonist_TubuleLength", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_TUBHUV_Antagonist_TubuleLength was analyzed at the endpoint, VALA_TUBHUV_Antagonist_TubuleLength, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is tubulogenesis.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "suramin", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "morphology", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "tubulogenesis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2808, + "assayComponentName": "VALA_TUBHUV_Antagonist_TubuleLength", + "assayComponentDesc": "VALA_TUBHUV_Antagonist_TubuleLength is the one of two assay components measured from the VALA_TUBHUV_Antagonist assay. It is designed to make measurements of tubulogenesis, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. This VALA_TUBHUV_Antagonist assay was designed to detect chemical suppression of tubulogenesis, i.e. antagonism.", + "assayComponentTargetDesc": "Vein growth supports angiogenesis, which is critical for development, maturation, and reproductive function. Dysregulation of angiogenesis can lead to birth defects, macular degeneration, impaired wound healing, and tumor growth. This assay measures compound effects on vein formation in complete medium, which contains growth factors that support vein endothelial cell proliferation. Tube formation antagonists will decrease vessel growth in these conditions.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "tubulogenesis", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD31 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mean tubule length", + "aid": 861, + "assayName": "VALA_TUBHUV_Antagonist", + "assayDesc": "VALA_TUBHUV_Antagonist is a cell-based, multiplexed assay that uses human umbilical vein endothelial cells (HUVEC). Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "umbilical vein-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HUVEC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3023, + "assayComponentEndpointName": "VALA_TUBIPS_Agonist_CellCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_TUBIPS_Agonist_CellCount was analyzed at the endpoint, VALA_TUBIPS_Agonist_CellCount, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cell count.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cell count", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2809, + "assayComponentName": "VALA_TUBIPS_Agonist_CellCount", + "assayComponentDesc": "VALA_TUBIPS_Agonist_CellCount is the one of two assay components measured from the VALA_TUBIPS_Agonist assay. It is designed to make measurements of viability, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to the number of DAPI labelled nuceli is indicative of the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "DAPI", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "labelled nuclei", + "aid": 862, + "assayName": "VALA_TUBIPS_Agonist", + "assayDesc": "VALA_TUBIPS_Agonist is a cell-based, multiplexed assay that uses human iPS-derived endothelial cells (iPSC). Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "iPS-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "iPSC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3024, + "assayComponentEndpointName": "VALA_TUBIPS_Agonist_TubuleLength", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_TUBIPS_Agonist_TubuleLength was analyzed at the endpoint, VALA_TUBIPS_Agonist_TubuleLength, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, gain-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is tubulogenesis.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "suramin", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "morphology", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "tubulogenesis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2810, + "assayComponentName": "VALA_TUBIPS_Agonist_TubuleLength", + "assayComponentDesc": "VALA_TUBIPS_Agonist_TubuleLength is the one of two assay components measured from the VALA_TUBIPS_Agonist assay. It is designed to make measurements of tubulogenesis, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. This VALA_TUBIPS1 assay was designed to detect chemical activation of tubulogenesis, i.e. agonism.", + "assayComponentTargetDesc": "Blood vessel growth supports angiogenesis, which is critical for development, maturation, and reproductive function. Dysregulation of angiogenesis can lead to birth defects, macular degeneration, impaired wound healing, and tumor growth. This assay measures compound effects on blood vessel formation in basal medium, which lacks growth factors that support vessel growth. Tube formation agonists will increase vessel growth in these conditions.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "tubulogenesis", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD31 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mean tubule length", + "aid": 862, + "assayName": "VALA_TUBIPS_Agonist", + "assayDesc": "VALA_TUBIPS_Agonist is a cell-based, multiplexed assay that uses human iPS-derived endothelial cells (iPSC). Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "iPS-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "iPSC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3025, + "assayComponentEndpointName": "VALA_TUBIPS_Antagonist_CellCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_TUBIPS_Antagonist_CellCount was analyzed at the endpoint, VALA_TUBIPS_Antagonist_CellCount, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cell count.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cell count", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2811, + "assayComponentName": "VALA_TUBIPS_Antagonist_CellCount", + "assayComponentDesc": "VALA_TUBIPS_Antagonist_CellCount is the one of two assay components measured from the VALA_TUBIPS_Antagonist assay. It is designed to make measurements of viability, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to the number of DAPI labelled nuceli is indicative of the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "DAPI", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "labelled nuclei", + "aid": 863, + "assayName": "VALA_TUBIPS_Antagonist", + "assayDesc": "VALA_TUBIPS_Agonist is a cell-based, multiplexed assay that uses human iPS-derived endothelial cells (iPSC). Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "iPS-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "iPSC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3026, + "assayComponentEndpointName": "VALA_TUBIPS_Antagonist_TubuleLength", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_TUBIPS_Antagonist_TubuleLength was analyzed at the endpoint, VALA_TUBIPS_Antagonist_TubuleLength, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is tubulogenesis.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "suramin", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "morphology", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "tubulogenesis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2812, + "assayComponentName": "VALA_TUBIPS_Antagonist_TubuleLength", + "assayComponentDesc": "VALA_TUBIPS_Antagonist_TubuleLength is the one of two assay components measured from the VALA_TUBIPS_Antagonist assay. It is designed to make measurements of tubulogenesis, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. This VALA_TUBIPS_Antagonist assay was designed to detect chemical suppression of tubulogenesis, i.e. antagonism.", + "assayComponentTargetDesc": "Blood vessel growth supports angiogenesis, which is critical for development, maturation, and reproductive function. Dysregulation of angiogenesis can lead to birth defects, macular degeneration, impaired wound healing, and tumor growth. This assay measures compound effects on blood vessel formation in complete medium, which contains growth factors that support vascular endothelial cell proliferation. Tube formation antagonists will decrease vessel growth in these conditions.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "tubulogenesis", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD31 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mean tubule length", + "aid": 863, + "assayName": "VALA_TUBIPS_Antagonist", + "assayDesc": "VALA_TUBIPS_Agonist is a cell-based, multiplexed assay that uses human iPS-derived endothelial cells (iPSC). Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "iPS-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "iPSC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3027, + "assayComponentEndpointName": "VALA_MIGHUV1_ScratchOnly_CellCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_MIGHUV1_ScratchOnly_CellCount was analyzed at the endpoint, VALA_MIGHUV1_ScratchOnly_CellCount, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cell count.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "BIO-acetoxime", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cell count", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2813, + "assayComponentName": "VALA_MIGHUV1_ScratchOnly_CellCount", + "assayComponentDesc": "VALA_MIGHUV1_ScratchOnly_CellCount is the one of two assay components measured from the VALA_MIGHUV1_ScratchOnly assay. It is designed to make measurements of viability, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to the number of DAPI labelled nuceli is indicative of the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "DAPI", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "labelled nuclei", + "aid": 864, + "assayName": "VALA_MIGHUV1_ScratchOnly", + "assayDesc": "VALA_MIGHUV1_ScratchOnly is a cell-based, multiplexed assay that uses umbilical vein-derived endothelial cells (HUVEC). Measurements were taken 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "umbilical vein-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HUVEC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3028, + "assayComponentEndpointName": "VALA_MIGHUV1_ScratchOnly_WoundArea", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_MIGHUV1_ScratchOnly_WoundArea was analyzed at the endpoint, VALA_MIGHUV1_ScratchOnly_WoundArea, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, gain-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is migration.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "cytochalasin D", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "migration", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "migration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2814, + "assayComponentName": "VALA_MIGHUV1_ScratchOnly_WoundArea", + "assayComponentDesc": "VALA_MIGHUV1_ScratchOnly_WoundArea is the one of two assay components measured from the VALA_MIGHUV1_ScratchOnly assay. It is designed to make measurements of endothelial migration, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Capillary growth supports angiogenesis, which is critical for development, maturation, and reproductive function. Dysregulation of angiogenesis can lead to birth defects, macular degeneration, impaired wound healing, and tumor growth. This assay measures compound effects on capillary network formation in basal medium, which lacks growth factors that support capillary growth. Tube formation agonists will increase capillary growth in these conditions.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell migration", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst dye", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "endothelial migration in wound recovery", + "aid": 864, + "assayName": "VALA_MIGHUV1_ScratchOnly", + "assayDesc": "VALA_MIGHUV1_ScratchOnly is a cell-based, multiplexed assay that uses umbilical vein-derived endothelial cells (HUVEC). Measurements were taken 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "umbilical vein-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HUVEC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3029, + "assayComponentEndpointName": "VALA_MIGHUV2_CellCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_MIGHUV2_CellCount was analyzed at the endpoint, VALA_MIGHUV2_CellCount, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cell count.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "BIO-acetoxime", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cell count", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2815, + "assayComponentName": "VALA_MIGHUV2_CellCount", + "assayComponentDesc": "VALA_MIGHUV2_CellCount is the one of two assay components measured from the VALA_MIGHUV2 assay. It is designed to make measurements of viability, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to the number of DAPI labelled nuceli is indicative of the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "DAPI", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "labelled nuclei", + "aid": 865, + "assayName": "VALA_MIGHUV2_Bcatenin", + "assayDesc": "VALA_MIGHUV2_BCatenin is a cell-based, multiplexed assay that uses umbilical vein-derived endothelial cells (HUVEC). Measurements were taken 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "umbilical vein-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HUVEC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3030, + "assayComponentEndpointName": "VALA_MIGHUV2_Bcatenin", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_MIGHUV2_BCatenin was analyzed at the endpoint, VALA_MIGHUV2_BCatenin, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, gain-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is migration.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "cytochalasin D", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "migration", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "migration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2816, + "assayComponentName": "VALA_MIGHUV2_Bcatenin", + "assayComponentDesc": "VALA_MIGHUV2_Bcatenin is the one of two assay components measured from the VALA_MIGHUV2 assay. It is designed to make measurements of nuclear translocation of CTNB, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Capillary growth supports angiogenesis, which is critical for development, maturation, and reproductive function. Dysregulation of angiogenesis can lead to birth defects, macular degeneration, impaired wound healing, and tumor growth. This assay measures compound effects on capillary network formation in complete medium, which contains growth factors that support capillary endothelial cell proliferation. Tube formation antagonists will decrease capillary growth in these conditions.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell migration", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CTNB", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "nuclear translocation of CTNB", + "aid": 865, + "assayName": "VALA_MIGHUV2_Bcatenin", + "assayDesc": "VALA_MIGHUV2_BCatenin is a cell-based, multiplexed assay that uses umbilical vein-derived endothelial cells (HUVEC). Measurements were taken 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "umbilical vein-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HUVEC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3031, + "assayComponentEndpointName": "VALA_MIGHUV2_WoundArea", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component VALA_MIGHUV2_WoundArea was analyzed at the endpoint, VALA_MIGHUV2_WoundArea, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, gain-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is migration.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "cytochalasin D", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "migration", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "migration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2817, + "assayComponentName": "VALA_MIGHUV2_WoundArea", + "assayComponentDesc": "VALA_MIGHUV2_WoundArea is the one of two assay components measured from the VALA_MIGHUV2 assay. It is designed to make measurements of endothelial migration, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Capillary growth supports angiogenesis, which is critical for development, maturation, and reproductive function. Dysregulation of angiogenesis can lead to birth defects, macular degeneration, impaired wound healing, and tumor growth. This assay measures compound effects on capillary network formation in complete medium, which contains growth factors that support capillary endothelial cell proliferation. Tube formation antagonists will decrease capillary growth in these conditions.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell migration", + "biologicalProcessTarget": "neurovascular unit NVU development (angiogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst dye", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "endothelial migration in wound recovery", + "aid": 865, + "assayName": "VALA_MIGHUV2_Bcatenin", + "assayDesc": "VALA_MIGHUV2_BCatenin is a cell-based, multiplexed assay that uses umbilical vein-derived endothelial cells (HUVEC). Measurements were taken 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "umbilical vein-derived endothelial cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HUVEC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 10, + "assaySourceName": "VALA", + "assaySourceLongName": "VALA Sciences", + "assaySourceDesc": "Vala Sciences, a Contract Research Organization (CRO), provides cell-based assay services.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 3032, + "assayComponentEndpointName": "CCTE_GLTED_hIYD", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_GLTED_hIYD was analyzed at the assay endpoint CCTE_GLTED_hIYD in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand iodotyrosine deiodinase activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'dehalogenase' intended target family, where the subfamily is 'iodotyrosine deiodinase'.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "3-Nitro-L-tyrosine (0.05 M NaOH for model inhibitor (MNT))", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "dehalogenase", + "intendedTargetFamilySub": "iodotyrosine deiodinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2818, + "assayComponentName": "CCTE_GLTED_hIYD", + "assayComponentDesc": "CCTE_GLTED_hIYD is the assay component measured from the CCTE_GLTED_hIYD assay. It measures substrate involved in regulation of catalytic activity using spectrophotometry. The assay measures the deiodination activity of human IYD on the substrate monoiodotyrosine (MIT). After 3h incubation of substrate, enzyme, and test chemical, the components are applied to a 96-well Dowex column. Free iodide is not retained by the column and is separated from interfering assay components. The free iodide is measured by the Sandell-Kolthoff reaction in which the rate of reduction of cerium (Ce+4 to Ce+3) by arsenic (As+3 to As+5) is increased by the presence of iodide. This is observed as the loss of yellow color in the reaction and the quantified by the change in absorbance at 420 nm. The change in reaction rate is proportional to the amount of iodide present.", + "assayComponentTargetDesc": "The iodide recycling enzyme, iodotyrosine deiodinase (IYD), is one conserved putative molecular target that plays an essential role in maintaining adequate levels of free iodide in the thyroid gland for hormone synthesis.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Colorimetric", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Monoiodotyrosine (MIT)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 866, + "assayName": "CCTE_GLTED_hIYD", + "assayDesc": "CCTE_GLTED_hIYD is a cell-free, single-readout assay that uses human iodotyrosine deiodinase (hIYD) enzyme produced with baculovirus-insect cell system. The assay is based on iodide release measured by the Sandell-Kolthoff method and is run in 96-well plate format with assay plates run in triplicate (n=3) with measurements taken at 3 hours after chemical dosing. Platewise-normalization was used based on positive control (3-Nitro-L-tyrosine, MNT) and negative/solvent controls (DMSO, NaOH).", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "baculovirus-insect cells", + "cellShortName": "SF-21", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.65, + "asid": 24, + "assaySourceName": "CCTE_GLTED", + "assaySourceLongName": "CCTE Great Lakes Toxicology and Ecology Division", + "assaySourceDesc": "The EPA CCTE Great Lakes Toxicology and Ecology Division focuses on ecotoxicology and stressors of water resources, including devleopment and implementation of in vitro and in vivo assays.", + "gene": { + "geneId": 24338, + "geneName": "iodotyrosine deiodinase", + "description": null, + "geneSymbol": "IYD", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 389434, + "officialSymbol": "IYD", + "officialFullName": "iodotyrosine deiodinase", + "uniprotAccessionNumber": null + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105073", + "url": "https://pubmed.ncbi.nlm.nih.gov/33352258/", + "pmid": 33352258, + "title": "In vitro screening for chemical inhibition of the iodide recycling enzyme, iodotyrosine deiodinase", + "author": "Olker JH, Korte JJ, Denny JS, Haselman JT, Hartig PC, Cardon MC, Hornung MW, Degitz SJ", + "citation": "Olker JH, Korte JJ, Denny JS, Haselman JT, Hartig PC, Cardon MC, Hornung MW, Degitz SJ. In vitro screening for chemical inhibition of the iodide recycling enzyme, iodotyrosine deiodinase. Toxicol In Vitro. 2021 Mar;71:105073. doi: 10.1016/j.tiv.2020.105073. Epub 2020 Dec 29. PMID: 33352258; PMCID: PMC8130633.", + "otherId": "0", + "citationId": 239, + "otherSource": "" + } + }, + { + "aeid": 3067, + "assayComponentEndpointName": "CCTE_Mundy_HCI_iCellGluta_NOG_BPCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_iCellGluta_NOG_BPCount was analyzed at the endpoint CCTE_Mundy_HCI_iCellGluta_NOG_BPCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss-of-signal activity can be used to understand developmental effects. This assay endpoint is considered less reliable by experts on the assay due to low occurrence of branch points in the iCell GlutaNeurons. Use data with caution.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2836, + "assayComponentName": "CCTE_Mundy_HCI_iCellGluta_NOG_BPCount", + "assayComponentDesc": "CCTE_Mundy_HCI_iCellGluta_NOG_BPCount is one of four components of the CCTE_Mundy_HCI_iCellGluta_NOG assay. It measures neurite outgrowth related to number of branch points using High Content Imaging of fluorescently labelled markers. This assay component is considered less reliable by experts on the assay due to low occurrence of branch points in the iCell GlutaNeurons. Use data with caution.", + "assayComponentTargetDesc": "Changes in the number of branch points are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of branch points", + "aid": 867, + "assayName": "CCTE_Mundy_HCI_iCellGluta_NOG", + "assayDesc": "CCTE_Mundy_HCI_iCellGluta_NOG is a multiplexed, cell-based-readout assay that uses iCell® GlutaNeurons from FUJIFILM Cellular Dynamics, Inc. (FCDI), human glutamatergic enriched neurons derived from induced pluripotent stem (iPS) cells, with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "secondary cell", + "cellFreeComponentSource": "human glutamatergic enriched neurons derived from induced pluripotent stem (iPS) cells", + "cellShortName": "iCell GlutaNeurons", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.15, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 3068, + "assayComponentEndpointName": "CCTE_Mundy_HCI_iCellGluta_NOG_NeuriteCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_iCellGluta_NOG_NeuriteCount was analyzed at the endpoint CCTE_Mundy_HCI_iCellGluta_NOG_NeuriteCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2837, + "assayComponentName": "CCTE_Mundy_HCI_iCellGluta_NOG_NeuriteCount", + "assayComponentDesc": "CCTE_Mundy_HCI_iCellGluta_NOG_NeuriteCount is one of four components of the CCTE_Mundy_HCI_iCellGluta_NOG assay. It measures neurite outgrowth related to number of neurites using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of neurites are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of neurites", + "aid": 867, + "assayName": "CCTE_Mundy_HCI_iCellGluta_NOG", + "assayDesc": "CCTE_Mundy_HCI_iCellGluta_NOG is a multiplexed, cell-based-readout assay that uses iCell® GlutaNeurons from FUJIFILM Cellular Dynamics, Inc. (FCDI), human glutamatergic enriched neurons derived from induced pluripotent stem (iPS) cells, with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "secondary cell", + "cellFreeComponentSource": "human glutamatergic enriched neurons derived from induced pluripotent stem (iPS) cells", + "cellShortName": "iCell GlutaNeurons", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.15, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 3069, + "assayComponentEndpointName": "CCTE_Mundy_HCI_iCellGluta_NOG_NeuriteLength", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_iCellGluta_NOG_NeuriteLength was analyzed at the endpoint CCTE_Mundy_HCI_iCellGluta_NOG_NeuriteLength in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2838, + "assayComponentName": "CCTE_Mundy_HCI_iCellGluta_NOG_NeuriteLength", + "assayComponentDesc": "CCTE_Mundy_HCI_iCellGluta_NOG_NeuriteLength is one of four components of the CCTE_Mundy_HCI_iCellGluta_NOG assay. It measures neurite outgrowth related to neurite length using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the neurite length are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "neurite length", + "aid": 867, + "assayName": "CCTE_Mundy_HCI_iCellGluta_NOG", + "assayDesc": "CCTE_Mundy_HCI_iCellGluta_NOG is a multiplexed, cell-based-readout assay that uses iCell® GlutaNeurons from FUJIFILM Cellular Dynamics, Inc. (FCDI), human glutamatergic enriched neurons derived from induced pluripotent stem (iPS) cells, with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "secondary cell", + "cellFreeComponentSource": "human glutamatergic enriched neurons derived from induced pluripotent stem (iPS) cells", + "cellShortName": "iCell GlutaNeurons", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.15, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 3070, + "assayComponentEndpointName": "CCTE_Mundy_HCI_iCellGluta_NOG_NeuronCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_iCellGluta_NOG_NeuronCount was analyzed at the endpoint CCTE_Mundy_HCI_iCellGluta_NOG_NeuronCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (10uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2839, + "assayComponentName": "CCTE_Mundy_HCI_iCellGluta_NOG_NeuronCount", + "assayComponentDesc": "CCTE_Mundy_HCI_iCellGluta_NOG_NeuronCount is one of four components of the CCTE_Mundy_HCI_iCellGluta_NOG assay. It measures cell viability related to number of neurons using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of neurons are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of neurons", + "aid": 867, + "assayName": "CCTE_Mundy_HCI_iCellGluta_NOG", + "assayDesc": "CCTE_Mundy_HCI_iCellGluta_NOG is a multiplexed, cell-based-readout assay that uses iCell® GlutaNeurons from FUJIFILM Cellular Dynamics, Inc. (FCDI), human glutamatergic enriched neurons derived from induced pluripotent stem (iPS) cells, with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "secondary cell", + "cellFreeComponentSource": "human glutamatergic enriched neurons derived from induced pluripotent stem (iPS) cells", + "cellShortName": "iCell GlutaNeurons", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.15, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.taap.2018.04.001", + "url": "https://pubmed.ncbi.nlm.nih.gov/29626487/", + "pmid": 29626487, + "title": "Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment", + "author": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR", + "citation": "Harrill JA, Freudenrich T, Wallace K, Ball K, Shafer TJ, Mundy WR. Testing for developmental neurotoxicity using a battery of in vitro assays for key cellular events in neurodevelopment. Toxicol Appl Pharmacol. 2018 Sep 1;354:24-39. doi: 10.1016/j.taap.2018.04.001. Epub 2018 Apr 5. PMID: 29626487.", + "otherId": "0", + "citationId": 240, + "otherSource": "" + } + }, + { + "aeid": 3072, + "assayComponentEndpointName": "CCTE_Deisenroth_5AR_NBTE_autofluor", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Deisenroth_5AR NBTE_autofluor was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Deisenroth_5AR NBTE_autofluor, was analyzed with bidirectional fitting relative to median test wells for the baseline of activity. Using a type of background reporter, gain-of-signal activity can be used to understand autofluorescence. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves an artifact detection function.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Tracer Fluorogenic Probe", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2841, + "assayComponentName": "CCTE_Deisenroth_5AR_NBTE_autofluor", + "assayComponentDesc": "CCTE_Deisenroth_5AR_NBTE_autofluor is one of four assay components measured from the CCTE_Deisenroth_5AR NBTE assay. It is designed to make measurements of a compound's autofluorescence, as detected by fluorescence intensity emission signals using spectrometry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence Intensity", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "autofluorescence probe", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 869, + "assayName": "CCTE_Deisenroth_5AR_NBTE", + "assayDesc": "CCTE_Deisenroth_5AR NBTE (5alpha-reductase NanoBRET Target Engagement Assay) is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 5 hours after chemical dosing in a 384 well plate. This assay includes a primary and secondary screen as well as an autofluorscence screen.", + "timepointHr": 5.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.3, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2018.08.017", + "url": "https://pubmed.ncbi.nlm.nih.gov/30205137/", + "pmid": 30205137, + "title": "", + "author": "Kleinstreuer NC, Browne P, Chang X, Judson R, Casey W, Ceger P, Deisenroth C, Baker N, Markey K, Thomas RS", + "citation": "Kleinstreuer NC, Browne P, Chang X, Judson R, Casey W, Ceger P, Deisenroth C, Baker N, Markey K, Thomas RS. Evaluation of androgen assay results using a curated Hershberger database. Reprod Toxicol. 2018 Oct;81:272-280. doi: 10.1016/j.reprotox.2018.08.017. Epub 2018 Sep 8. PMID: 30205137; PMCID: PMC7171594.", + "otherId": "0", + "citationId": 262, + "otherSource": "" + } + }, + { + "aeid": 3074, + "assayComponentEndpointName": "CCTE_Deisenroth_5AR_NBTE_donor", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Deisenroth_5AR NBTE_donor was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Deisenroth_5AR NBTE_donor, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity can be used to understand changes in the donor luminescence as related to 5alpha-reductase catalytic function. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves an artifact detection function.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Dutasteride, Finasteride", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact luminescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2842, + "assayComponentName": "CCTE_Deisenroth_5AR_NBTE_donor", + "assayComponentDesc": "CCTE_Deisenroth_5AR NBTE_donor is one of four assay components measured from the CCTE_Deisenroth_5AR NBTE assay. It is designed to make measurements of donor luminescence, as detected by bioluminescence intensity emission signals using spectrometry technology.", + "assayComponentTargetDesc": "The technology is based on the concept of Bioluminescence Resonance Energy Transfer BRET. Target proteins fused to NanoLuc luciferase generate luminescence signal in the presence of furimazine substrate. BRET occurs when custom fluorescent tracers, bound to the target protein, resonate luminescent energy from the luciferase enzyme to the tracer molecule to yield a lower-energy fluorescent emission signal.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "donor luminescence emission", + "biologicalProcessTarget": "regulation of 5alpha-reductase enzyme activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Luminescence Intensity", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "luciferase substrate: furimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-specified", + "aid": 869, + "assayName": "CCTE_Deisenroth_5AR_NBTE", + "assayDesc": "CCTE_Deisenroth_5AR NBTE (5alpha-reductase NanoBRET Target Engagement Assay) is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 5 hours after chemical dosing in a 384 well plate. This assay includes a primary and secondary screen as well as an autofluorscence screen.", + "timepointHr": 5.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.3, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2018.08.017", + "url": "https://pubmed.ncbi.nlm.nih.gov/30205137/", + "pmid": 30205137, + "title": "", + "author": "Kleinstreuer NC, Browne P, Chang X, Judson R, Casey W, Ceger P, Deisenroth C, Baker N, Markey K, Thomas RS", + "citation": "Kleinstreuer NC, Browne P, Chang X, Judson R, Casey W, Ceger P, Deisenroth C, Baker N, Markey K, Thomas RS. Evaluation of androgen assay results using a curated Hershberger database. Reprod Toxicol. 2018 Oct;81:272-280. doi: 10.1016/j.reprotox.2018.08.017. Epub 2018 Sep 8. PMID: 30205137; PMCID: PMC7171594.", + "otherId": "0", + "citationId": 262, + "otherSource": "" + } + }, + { + "aeid": 3076, + "assayComponentEndpointName": "CCTE_Deisenroth_5AR_NBTE_acceptor", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Deisenroth_5AR NBTE_acceptor was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Deisenroth_5AR NBTE_acceptor, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity can be used to understand changes in the acceptor fluorescence as related to 5alpha-reductase catalytic function. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves an artifact detection function.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Dutasteride, Finasteride", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2843, + "assayComponentName": "CCTE_Deisenroth_5AR_NBTE_acceptor", + "assayComponentDesc": "CCTE_Deisenroth_5AR NBTE_acceptor is one of four assay components measured from the CCTE_Deisenroth_5AR NBTE assay. It is designed to make measurements of resonant fluorescence generated by bioluminescent energy transfer to a target fluorophore, as detected by fluorescence intensity emission signals using spectrometry technology.", + "assayComponentTargetDesc": "The technology is based on the concept of Bioluminescence Resonance Energy Transfer BRET. Target proteins fused to NanoLuc luciferase generate luminescence signal in the presence of furimazine substrate. BRET occurs when custom fluorescent tracers, bound to the target protein, resonate luminescent energy from the luciferase enzyme to the tracer molecule to yield a lower-energy fluorescent emission signal.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "acceptor fluorescence emission", + "biologicalProcessTarget": "regulation of 5alpha-reductase enzyme activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence Intensity", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "tracer fluorogenic probe: MC547-NanoBRET 590 SE", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-specified", + "aid": 869, + "assayName": "CCTE_Deisenroth_5AR_NBTE", + "assayDesc": "CCTE_Deisenroth_5AR NBTE (5alpha-reductase NanoBRET Target Engagement Assay) is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 5 hours after chemical dosing in a 384 well plate. This assay includes a primary and secondary screen as well as an autofluorscence screen.", + "timepointHr": 5.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.3, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2018.08.017", + "url": "https://pubmed.ncbi.nlm.nih.gov/30205137/", + "pmid": 30205137, + "title": "", + "author": "Kleinstreuer NC, Browne P, Chang X, Judson R, Casey W, Ceger P, Deisenroth C, Baker N, Markey K, Thomas RS", + "citation": "Kleinstreuer NC, Browne P, Chang X, Judson R, Casey W, Ceger P, Deisenroth C, Baker N, Markey K, Thomas RS. Evaluation of androgen assay results using a curated Hershberger database. Reprod Toxicol. 2018 Oct;81:272-280. doi: 10.1016/j.reprotox.2018.08.017. Epub 2018 Sep 8. PMID: 30205137; PMCID: PMC7171594.", + "otherId": "0", + "citationId": 262, + "otherSource": "" + } + }, + { + "aeid": 3078, + "assayComponentEndpointName": "CCTE_Deisenroth_5AR_NBTE_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Deisenroth_5AR NBTE_ratio was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Deisenroth_5AR NBTE_ratio, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity can be used to understand changes in 5alpha-reductase catalytic function. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the misc protein intended target family, where the subfamily is 5-alpha reductase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Dutasteride, Finasteride", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "misc protein", + "intendedTargetFamilySub": "5-alpha reductase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2844, + "assayComponentName": "CCTE_Deisenroth_5AR_NBTE_ratio", + "assayComponentDesc": "CCTE_Deisenroth_5AR NBTE_ratio is one of four assay components calculated from the CCTE_Deisenroth_5AR NBTE assay. It is designed to measure the ratio of target acceptor fluorophore resonance to donor bioluminescent signals.", + "assayComponentTargetDesc": "The ratio of acceptor signal fluorescence to donor signal luminescence yields a normalized quantitative value in milliBRET Units mBU that can be used to evaluate direct disruption of small molecule target protein interactions of 5 alpha reductase.", + "parameterReadoutType": "single", + "assayDesignType": "ratiometric", + "assayDesignTypeSub": "ratio", + "biologicalProcessTarget": "regulation of 5alpha-reductase enzyme activity", + "detectionTechnologyType": "Bioluminescence Resonance Energy Transfer", + "detectionTechnologyTypeSub": "Bioluminescence Resonance Energy Transfer Ratio", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "ratio", + "keyAssayReagent": "acceptor/donor", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 869, + "assayName": "CCTE_Deisenroth_5AR_NBTE", + "assayDesc": "CCTE_Deisenroth_5AR NBTE (5alpha-reductase NanoBRET Target Engagement Assay) is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 5 hours after chemical dosing in a 384 well plate. This assay includes a primary and secondary screen as well as an autofluorscence screen.", + "timepointHr": 5.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.3, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2018.08.017", + "url": "https://pubmed.ncbi.nlm.nih.gov/30205137/", + "pmid": 30205137, + "title": "", + "author": "Kleinstreuer NC, Browne P, Chang X, Judson R, Casey W, Ceger P, Deisenroth C, Baker N, Markey K, Thomas RS", + "citation": "Kleinstreuer NC, Browne P, Chang X, Judson R, Casey W, Ceger P, Deisenroth C, Baker N, Markey K, Thomas RS. Evaluation of androgen assay results using a curated Hershberger database. Reprod Toxicol. 2018 Oct;81:272-280. doi: 10.1016/j.reprotox.2018.08.017. Epub 2018 Sep 8. PMID: 30205137; PMCID: PMC7171594.", + "otherId": "0", + "citationId": 262, + "otherSource": "" + } + }, + { + "aeid": 3086, + "assayComponentEndpointName": "TAMU_PeakParms_SingleDonor1434_Asystole", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TAMU_PeakParms_SingleDonor1434_Asystole was analyzed into 1 assay endpoint. This assay endpoint, TAMU_PeakParms_SingleDonor1434_Asystole, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, loss-of-signal activity can be used to understand changes in the cardiac function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cardiomyocyte function intended target family, where the subfamily is cessation of beating.", + "assayFunctionType": "cardiac function", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential ", + "intendedTargetFamily": "cardiomyocyte function", + "intendedTargetFamilySub": "cessation of beating", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2848, + "assayComponentName": "TAMU_PeakParms_SingleDonor1434_Asystole", + "assayComponentDesc": "TAMU_PeakParms_SingleDonor1434_Chronotopy is a phenotype derived from the peak.freq.avg parameter and uses an EC95 as its POD (95% decrease in beat rate, compared to controls). Peak.Freq.Avg measures the average peak frequency, in beats per second, uisng Fluorescence intensity as a functional reporter from Calcium (Ca+2) flux assay technology. There is no preprocessing performed on the data used to model this phenotype.", + "assayComponentTargetDesc": "Changes in the calcium flux readouts is used to quantify changes in peak frequency, which can be an indication of the cessation of beating", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "beating", + "biologicalProcessTarget": "cardiac function", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Calcium (Ca+2) flux assay", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Ca+2 dye reagent", + "technologicalTargetType": "calcium influx rate", + "technologicalTargetTypeSub": "average peak frequency, in beats per second", + "aid": 845, + "assayName": "TAMU_PeakParms", + "assayDesc": "TAMU_PeakParms is a cell-based, multiplexed-readout assay that uses iPSC-derived cardiomyocytes with measurements taken at 1.5 hours after chemical dosing in a microplate: 384-well plate.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "heart", + "cellFormat": "cell-based", + "cellFreeComponentSource": "iPSC-derived cardiomyocytes", + "cellShortName": "NA", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 29, + "assaySourceName": "TAMU", + "assaySourceLongName": "Texas A&M University", + "assaySourceDesc": null, + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.1c00203", + "url": "https://pubmed.ncbi.nlm.nih.gov/34448577/", + "pmid": 34448577, + "title": "Cardiotoxicity Hazard and Risk Characterization of ToxCast Chemicals Using Human Induced Pluripotent Stem Cell-Derived Cardiomyocytes from Multiple Donors", + "author": "Burnett SD, Blanchette AD, Chiu WA, Rusyn I", + "citation": "Burnett SD, Blanchette AD, Chiu WA, Rusyn I. Cardiotoxicity Hazard and Risk Characterization of ToxCast Chemicals Using Human Induced Pluripotent Stem Cell-Derived Cardiomyocytes from Multiple Donors. Chem Res Toxicol. 2021 Aug 27. doi: 10.1021/acs.chemrestox.1c00203. Epub ahead of print. PMID: 34448577.", + "otherId": "0", + "citationId": 286, + "otherSource": "" + } + }, + { + "aeid": 3087, + "assayComponentEndpointName": "IUF_NPC1_cytotoxicity_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the IUF_NPC1_cytotoxicity_72hr component was analyzed at the endpoint IUF_NPC1_cytotoxicity_72hr in the positive analysis fitting direction relative to the dynamic range and baseline of activity. Using a type of viability reporter, gain-of-signal activity can be used to understand cytotoxicity effects.", + "assayFunctionType": "cytotoxicity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "lysed cells", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "enzyme activity", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2849, + "assayComponentName": "IUF_NPC1_cytotoxicity_72hr", + "assayComponentDesc": "IUF_NPC1_cytotoxicity_72hr is one of 4 assay components measured from the IUF_NPC1 assay. It is designed to measure cytotoxicity at 72 hrs due to loss of membrane integrity. LDH measurements are performed from medium supernatants of each well and are based on the reduction of resazurin to resorufin measured as fluorescence signal (relative fluorescence unit) in a multiplate reader. ", + "assayComponentTargetDesc": "Changes in enzymatic activity (increase in lactate dehydrogenase) are indicative of compromised cell health. Reductions in the total LDH (in cells), indicates cell loss or death.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "cytotoxicity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "membrane integrity assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "resazurin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme: lactate dehydrogenase", + "aid": 846, + "assayName": "IUF_NPC1", + "assayDesc": "IUF_NPC1 is a cell-based, multiplexed assay that uses hNPC, a human primary neural progenitor cells, with measurements taken at 72 hours after chemical dosing in a 96-well plate. Human neural progenitor cells (hNPC) are generated from human fetal brain cortex at gestational week (GW) 16-19. Grown in suspension culture and under proliferative conditions (proliferation media and growth factors), these cells represent neural progenitor cell proliferation. In the NPC1 assay, hNPC's are exposed to the test compound for 72h. Cell proliferation is assessed as an increase in sphere area using automated phase contrast imaging and as incorporation of Bromodeoxyuridine (BrdU) during DNA synthesis using a luminescence-based cell proliferation ELISA. In parallel, the cell viability is assessed using an alamar blue viability assay and the cytotoxicity using a lactate dehydrogenase dependent membrane integrity assay.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "primary cell", + "cellFreeComponentSource": "neural progenitor cells", + "cellShortName": "hNPC", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 30, + "assaySourceName": "IUF", + "assaySourceLongName": "Leibniz Research Institute for Environmental Medicine", + "assaySourceDesc": "Leibniz Research Institute for Environmental Medicine (IUF) is a German research institution in Düsseldorf. The IUF research mission is the molecular prevention of environmentally induced health disorders.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1007/s00204-015-1568-8", + "url": "https://pubmed.ncbi.nlm.nih.gov/26216354/", + "pmid": 26216354, + "title": "Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events", + "author": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E.", + "citation": "Baumann J, Gassmann K, Masjosthusmann S, DeBoer D, Bendt F, Giersiefer S, Fritsche E. Comparative human and rat neurospheres reveal species differences in chemical effects on neurodevelopmental key events. Arch Toxicol. 2016 Jun;90(6):1415-27. doi: 10.1007/s00204-015-1568-8. Epub 2015 Jul 28. PMID: 26216354.", + "otherId": "0", + "citationId": 279, + "otherSource": "" + } + }, + { + "aeid": 3088, + "assayComponentEndpointName": "CCTE_GLTED_hTBG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_GLTED_hTBG was analyzed at the assay endpoint CCTE_GLTED_hTBG in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand a chemical's ability to displace T4 from thyroxine-binding globulin. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'transporter' intended target family, where the subfamily is 'hormone carrier protein'.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "3,5,3,5-tetraiodothyronine (T4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "hormone carrier protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2850, + "assayComponentName": "CCTE_GLTED_hTBG", + "assayComponentDesc": "CCTE_GLTED_hTBG is the assay component measured from the CCTE_GLTED_hTBG assay. It is designed to make measurements of fluorescent polarization, using a form of binding reporter, as detected with Fluorescence signals by Fluorescence technology.", + "assayComponentTargetDesc": "Thyroxine-binding globulin (TBG) is one the major transport proteins responsible for binding to and transporting thyroid hormones to the necessary tissues.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "fluorescent polarization", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ANSA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 870, + "assayName": "CCTE_GLTED_hTBG", + "assayDesc": "CCTE_GLTED_hTBG is a cell-free, single-readout assay designed to test the chemicals' ability to displace T4 from the human thyroxine-binding globulin (TBG) protein. TBG is incubated in presence of test chemical for 2 hours during which disrupting chemicals displace ANSA from the TBG protein. Results read fluorescence at 380 excitation and 475 emission.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "Human plasma", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 24, + "assaySourceName": "CCTE_GLTED", + "assaySourceLongName": "CCTE Great Lakes Toxicology and Ecology Division", + "assaySourceDesc": "The EPA CCTE Great Lakes Toxicology and Ecology Division focuses on ecotoxicology and stressors of water resources, including devleopment and implementation of in vitro and in vivo assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3089, + "assayComponentEndpointName": "CCTE_GLTED_hTTR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_GLTED_hTTR was analyzed at the assay endpoint CCTE_GLTED_hTTR in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, loss-of-signal activity can be used to understand a chemical's ability to displace T4 from transthyretin. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'transporter' intended target family, where the subfamily is 'hormone carrier protein'.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "3,5,3,5-tetraiodothyronine (T4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "hormone carrier protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2851, + "assayComponentName": "CCTE_GLTED_hTTR", + "assayComponentDesc": "CCTE_GLTED_hTTR is the assay component measured from the CCTE_GLTED_hTTR assay. It is designed to make measurements of fluorescent polarization, using a form of binding reporter, as detected with Fluorescence signals by Fluorescence technology.", + "assayComponentTargetDesc": "Transthyretin (TTR) is one the major transport proteins responsible for binding to and transporting thyroid hormones to the necessary tissues.", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "fluorescent polarization", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ANSA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 871, + "assayName": "CCTE_GLTED_hTTR", + "assayDesc": "CCTE_GLTED_hTTR is a cell-free, single-readout assay designed to test the chemicals' ability to displace T4 from the human transthyretin (TTR) protein. TTR is incubated in presence of test chemical for 2 hours during which disrupting chemicals displace ANSA from the TTR protein. Results read fluorescence at 380 excitation and 475 emission.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "Human plasma", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 24, + "assaySourceName": "CCTE_GLTED", + "assaySourceLongName": "CCTE Great Lakes Toxicology and Ecology Division", + "assaySourceDesc": "The EPA CCTE Great Lakes Toxicology and Ecology Division focuses on ecotoxicology and stressors of water resources, including devleopment and implementation of in vitro and in vivo assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3090, + "assayComponentEndpointName": "CCTE_GLTED_hTPO", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_GLTED_hTPO was analyzed at the assay endpoint CCTE_GLTED_hTPO in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter (the Amplex UltraRed assay), loss-of-signal activity can be used to understand decreased peroxidase activity in the presence of excess hydrogen peroxidase. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'oxidoreductase' intended target family, where the subfamily is 'peroxidase'.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methimizole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "peroxidase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2852, + "assayComponentName": "CCTE_GLTED_hTPO", + "assayComponentDesc": "CCTE_GLTED_hTPO is the assay component measured from the CCTE_GLTED_hTPO assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by Fluorescence technology.", + "assayComponentTargetDesc": "A well-characterized MIE for adverse thyroid-mediated outcomes is inhibition of TPO. TPO catalyzes iodine oxidation in the presence of hydrogen peroxide, regulates nonspecific iodination of tyrosyl residues of thyroglobulin to form TH precursors, monoiodotyrosine (MIT), and diiodotyrosine (DIT), and modulates coupling of these iodotyrosyl residues.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Amplex UltraRed", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 872, + "assayName": "CCTE_GLTED_hTPO", + "assayDesc": "CCTE_GLTED_hTPO is a cell-free, single-readout assay designed to test the inhibitory activity of chemicals toward human thyroperoxidase (TPO) protein. Uninhibited enzyme converts Amplex UltraRed to a fluorescent product. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate.                                               ", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "HEK293", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 24, + "assaySourceName": "CCTE_GLTED", + "assaySourceLongName": "CCTE Great Lakes Toxicology and Ecology Division", + "assaySourceDesc": "The EPA CCTE Great Lakes Toxicology and Ecology Division focuses on ecotoxicology and stressors of water resources, including devleopment and implementation of in vitro and in vivo assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3091, + "assayComponentEndpointName": "CCTE_GLTED_xDIO3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_GLTED_xDIO3 was analyzed at the assay endpoint CCTE_GLTED_xDIO3 in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand deiodinase Type 3 activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'deiodinase' intended target family, where the subfamily is 'deiodinase Type 3'.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "xanthohumol", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "deiodinase", + "intendedTargetFamilySub": "deiodinase Type 3", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2853, + "assayComponentName": "CCTE_GLTED_xDIO3", + "assayComponentDesc": "CCTE_GLTED_xDIO3 is the assay component measured from the CCTE_GLTED_xDIO assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by spectrophotometry.", + "assayComponentTargetDesc": "Deiodinase enzymes play an essential role in converting thyroid hormones between active and inactive forms by deiodinating the pro-hormone thyroxine (T4) to the active hormone triiodothyronine (T3) and modifying T4 and T3 to inactive forms. DIO3 inactivates both T4 and T3 by removing an inner ring iodine, producing reverse T3 (rT3) and diiodotyrosine (T2), respectively.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Colorimetric", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "3,3',5-triiodothyronine (T3)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 873, + "assayName": "CCTE_GLTED_xDIO3", + "assayDesc": "CCTE_GLTED_xDIO3 is a cell-free, single-readout assay designed to test the inhibitory activity of chemicals toward Xenopus (frog) iodothyronine Deiodinase Type 3 (DIO3) enzyme. Enzyme is incubated in presence of test chemical for 3 hours during which uninhibited enzyme liberates free iodide from substrate. Free iodide is measured in a second step using the Sandell-Kolthoff method.", + "timepointHr": 3.0, + "organismId": 8355, + "organism": "xenopus (frog)", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "HEK293", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 24, + "assaySourceName": "CCTE_GLTED", + "assaySourceLongName": "CCTE Great Lakes Toxicology and Ecology Division", + "assaySourceDesc": "The EPA CCTE Great Lakes Toxicology and Ecology Division focuses on ecotoxicology and stressors of water resources, including devleopment and implementation of in vitro and in vivo assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3092, + "assayComponentEndpointName": "CCTE_GLTED_xIYD", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_GLTED_xIYD was analyzed at the assay endpoint CCTE_GLTED_xIYD in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand iodotyrosine deiodinase activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'dehalogenase' intended target family, where the subfamily is 'iodotyrosine deiodinase'.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "3-Nitro-L-tyrosine (MNT)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "dehalogenase", + "intendedTargetFamilySub": "iodotyrosine deiodinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2854, + "assayComponentName": "CCTE_GLTED_xIYD", + "assayComponentDesc": "CCTE_GLTED_xIYD is the assay component measured from the CCTE_GLTED_xIYD assay. It measures substrate involved in regulation of catalytic activity using spectrophotometry. The assay measures the deiodination activity of Xenopus (frog) IYD on the substrate monoiodotyrosine (MIT). After 3h incubation of substrate, enzyme, and test chemical, the components are applied to a 96-well Dowex column. Free iodide is not retained by the column and is separated from interfering assay components. The free iodide is measured by the Sandell-Kolthoff reaction in which the rate of reduction of cerium (Ce+4 to Ce+3) by arsenic (As+3 to As+5) is increased by the presence of iodide. This is observed as the loss of yellow color in the reaction and the quantified by the change in absorbance at 420 nm. The change in reaction rate is proportional to the amount of iodide present.", + "assayComponentTargetDesc": "The iodide recycling enzyme, iodotyrosine deiodinase (IYD), is one conserved putative molecular target that plays an essential role in maintaining adequate levels of free iodide in the thyroid gland for hormone synthesis.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Colorimetric", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "3-iodotyrosine (MIT)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 874, + "assayName": "CCTE_GLTED_xIYD", + "assayDesc": "CCTE_GLTED_xIYD is a cell-free, single-readout assay that uses Xenopus (frog) iodotyrosine deiodinase (xIYD) enzyme from liver microsomes. Assay is based on iodide release measured by the Sandell-Kolthoff method and is run in 96-well plate format with assay plates run in triplicate (n=3) with measurements taken at 3 hours after chemical dosing. Platewise-normalization was used based on positive control (3-Nitro-L-tyrosine, MNT) and negative/solvent controls (DMSO, NaOH).", + "timepointHr": 3.0, + "organismId": 8355, + "organism": "xenopus (frog)", + "tissue": "liver", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "frog liver", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 24, + "assaySourceName": "CCTE_GLTED", + "assaySourceLongName": "CCTE Great Lakes Toxicology and Ecology Division", + "assaySourceDesc": "The EPA CCTE Great Lakes Toxicology and Ecology Division focuses on ecotoxicology and stressors of water resources, including devleopment and implementation of in vitro and in vivo assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3094, + "assayComponentEndpointName": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Sox17", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Sox17 was analyzed into 2 assay endpoint. This assay endpoint, CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Sox17, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline activity. Using a type of inducible reporter, gain or loss-of-signal activity can be used to understand changes in gene expression. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves as a measure of endoderm differentiation. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transcription factor intended target family, where the subfamily is SRY-related HMG-box.", + "assayFunctionType": "gene expression", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "SB431542", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "transcription factor", + "intendedTargetFamilySub": "SRY-related HMG-box", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2855, + "assayComponentName": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Sox17", + "assayComponentDesc": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Sox17 is one of 4 assay components calculated from the CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo assay and it measures an increase in the percentage of cells in an endoderm state. It is designed to make measurements of inducible reporter a form of fluorescent protein induction as detected with optical fluorescence microscopy. Percentage Sox17+ cells are determined by calculating the number of Sox17+ cells divided by cell count. A cell is Sox17+ if the cell Sox17 mean intensity is 5x BMAD above the pluripotent control median cell Sox17 mean. The assay endpoints were analyzed with bidirectional fitting relative to 0.2% DMSO control in the CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo assay.", + "assayComponentTargetDesc": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Sox17 was designed to measure changes in cellular Sox17 expression. Changes are indicative of changes in Sox17 gene expression due to perturbations in endoderm differentiation.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "fluorescent protein induction", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "microscopy", + "detectionTechnologyTypeSub": "optical microscopy: fluorescence microscopy", + "detectionTechnology": "microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transcription factor", + "aid": 875, + "assayName": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo", + "assayDesc": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo assay is a cell-based, multiplex-readout assay that uses RUES2-GLR, a human pluripotent cell line, with measurements taken at 48 hours after chemical dosing in a 384-well microplate", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "pluripotent cell line", + "cellFormat": "cell-based", + "cellFreeComponentSource": "NA", + "cellShortName": "RUES2-GLR", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3095, + "assayComponentEndpointName": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Sox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Sox2 was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Sox2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in gene expression. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as a measure of pluripotency or ectoderm differentiation. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transcription factor intended target family, where the subfamily is SRY-related HMG-box.", + "assayFunctionType": "gene expression", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "transcription factor", + "intendedTargetFamilySub": "SRY-related HMG-box", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2856, + "assayComponentName": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Sox2", + "assayComponentDesc": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Sox2 is one of 4 assay components calculated from the CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo assay that measures an increase in the percentage of cells in an ectodermal or pluripotent state. It is designed to make measurements of inducible reporter a form of fluorescent protein induction as detected with optical fluorescence microscopy. Percentage Sox2+ cells are determined by calculating the number of Sox2+ cells divided by cell count. A cell is Sox2+ if the cell Sox2 mean intensity is 5x BMAD above the directed endoderm control median cell Sox2 mean. The assay endpoint was analyzed with bidirectional fitting with the 0.2% DMSO control median percent Sox2 in the CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo assay subtracted.", + "assayComponentTargetDesc": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Sox2 was designed to measure changes in cellular Sox2 expression. Changes are indicative of changes in Sox2 protein expression due to perturbations in endoderm differentiation.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "fluorescent protein induction", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "microscopy", + "detectionTechnologyTypeSub": "optical microscopy: fluorescence microscopy", + "detectionTechnology": "microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transcription factor", + "aid": 875, + "assayName": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo", + "assayDesc": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo assay is a cell-based, multiplex-readout assay that uses RUES2-GLR, a human pluripotent cell line, with measurements taken at 48 hours after chemical dosing in a 384-well microplate", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "pluripotent cell line", + "cellFormat": "cell-based", + "cellFreeComponentSource": "NA", + "cellShortName": "RUES2-GLR", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3096, + "assayComponentEndpointName": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Bra", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Bra was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Bra, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in gene expression. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as a measure of mesoderm differentiation. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transcription factor intended target family, where the subfamily is T-box protein.", + "assayFunctionType": "gene expression", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "transcription factor", + "intendedTargetFamilySub": "T-box protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2857, + "assayComponentName": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Bra", + "assayComponentDesc": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Bra is one of 4 assay components calculated from the CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo assay that measures an increase in the percentage of cells in an endoderm state. It is designed to make measurements of inducible reporter a form of fluorescent protein induction as detected with optical fluorescence microscopy. Percentage Bra+ cells are determined by calculating the number of Bra+ cells divided by cell count. A cell is Bra+ if the cell Bra mean intensity is 5x BMAD above the pluripotent control median cell Bra mean. The assay endpoint was analyzed with bidirectional fitting with the 0.2% DMSO control median percent Bra in the DEVTOX_RUES2-GLR assay subtracted.", + "assayComponentTargetDesc": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_Bra was designed to measure changes in cellular Bra expression. Changes are indicative of changes in Bra gene expression due to perturbations in endoderm differentiation", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "fluorescent protein induction", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "microscopy", + "detectionTechnologyTypeSub": "optical microscopy: fluorescence microscopy", + "detectionTechnology": "microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transcription factor", + "aid": 875, + "assayName": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo", + "assayDesc": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo assay is a cell-based, multiplex-readout assay that uses RUES2-GLR, a human pluripotent cell line, with measurements taken at 48 hours after chemical dosing in a 384-well microplate", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "pluripotent cell line", + "cellFormat": "cell-based", + "cellFreeComponentSource": "NA", + "cellShortName": "RUES2-GLR", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3098, + "assayComponentEndpointName": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_CellCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_CellCount was analyzed into 2 assay endpoint. This assay endpoint, CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_CellCount, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline activity. Using nuclei counting, gain or loss-of-signal activity can be used to understand changes in cell viability. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves as a measure of cytotoxicity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2858, + "assayComponentName": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_CellCount", + "assayComponentDesc": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_CellCount is one of 4 assay components calculated from the CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo assay that measures an increase in cell count. It is designed to make measurements of nuclei count, a form of cell viability, as detected with optical fluorescence microscopy by Perkin Elmer Harmony nuclei detection algorithm. The assay endpoints were analyzed with bidirectional fitting relative to 0.2% DMSO control in the DEVTOX_RUES2-GLR assay.", + "assayComponentTargetDesc": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo_CellCount was designed to measure changes in the number cells. Changes are indicative of cytotoxicity. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell number", + "biologicalProcessTarget": "cell viability", + "detectionTechnologyType": "microscopy", + "detectionTechnologyTypeSub": "optical microscopy: fluorescence microscopy", + "detectionTechnology": "Perkin Elmer Harmony nuclei detection algorithm ", + "keyAssayReagentType": "stain", + "keyAssayReagent": "fluorescent signal", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "nucleus", + "aid": 875, + "assayName": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo", + "assayDesc": "CCTE_Deisenroth_DEVTOX_RUES2-GLR_Endo assay is a cell-based, multiplex-readout assay that uses RUES2-GLR, a human pluripotent cell line, with measurements taken at 48 hours after chemical dosing in a 384-well microplate", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "pluripotent cell line", + "cellFormat": "cell-based", + "cellFreeComponentSource": "NA", + "cellShortName": "RUES2-GLR", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3099, + "assayComponentEndpointName": "ATG_frGR_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frGR_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene for glucocorticoid receptor. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Dexamethasone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2860, + "assayComponentName": "ATG_frGR_EcoTox2", + "assayComponentDesc": "ATG_frGR_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element frGR, also known as african clawed frog (Xenopus laevis) glucocorticoid receptor. [NCBI Reference Sequence: NP_001081531.1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frGR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3101, + "assayComponentEndpointName": "ATG_rtGR_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_rtGR_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene for glucocorticoid receptor. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Dexamethasone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2861, + "assayComponentName": "ATG_rtGR_EcoTox2", + "assayComponentDesc": "ATG_rtGR_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element rtGR, also known as rainbow trout (Oncorhynchus mykiss) glucocorticoid receptor. [NCBI Reference Sequence: NP_001118202.1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-rtGR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3103, + "assayComponentEndpointName": "ATG_jmGR_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_jmGR_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene for glucocorticoid receptor. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Dexamethasone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2862, + "assayComponentName": "ATG_jmGR_EcoTox2", + "assayComponentDesc": "ATG_jmGR_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element mGR, also known as japanese medaka (Oryzias latipes) glucocorticoid receptor. [NCBI Reference Sequence: NNP_001292330.1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-jmGR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3105, + "assayComponentEndpointName": "ATG_zfGR_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfGR_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene for glucocorticoid receptor. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Dexamethasone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2863, + "assayComponentName": "ATG_zfGR_EcoTox2", + "assayComponentDesc": "ATG_zfGR_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element zfGR, also known as zebrafish (Danio rerio) glucocorticoid receptor. [NCBI Reference Sequence: NP_001018547.2].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfGR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3107, + "assayComponentEndpointName": "ATG_hPPARa_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hPPARa_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARa. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "GW7647", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2864, + "assayComponentName": "ATG_hPPARa_EcoTox2", + "assayComponentDesc": "ATG_hPPARa_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element hPPARg, which is responsive to the human peroxisome proliferator activated receptor alpha. NCBI Reference Sequence: NP_005027.2]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-hPPARa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3109, + "assayComponentEndpointName": "ATG_frPPARa_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frPPARa_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARa. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "GW7647", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2865, + "assayComponentName": "ATG_frPPARa_EcoTox2", + "assayComponentDesc": "ATG_frPPARa_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element frPPARg, which is responsive to the african clawed frog (Xenopus laevis) peroxisome proliferator activated receptor alpha. NCBI Reference Sequence: NP_001083282.1]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frPPARa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3111, + "assayComponentEndpointName": "ATG_rtPPARa_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frPPARa_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARa. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "GW7647", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2866, + "assayComponentName": "ATG_rtPPARa_EcoTox2", + "assayComponentDesc": "ATG_rtPPARa_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element rtPPARg, which is responsive to the rainbow trout (Oncorhynchus mykiss) peroxisome proliferator activated receptor alpha. NCBI Reference Sequence: XP_021473593.1]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-rtPPARa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3113, + "assayComponentEndpointName": "ATG_jmPPARa_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_jmPPARa_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARa. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "GW7647", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2867, + "assayComponentName": "ATG_jmPPARa_EcoTox2", + "assayComponentDesc": "ATG_jmPPARa_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element jmPPARg, which is responsive to the japanese medaka (Oryzias latipes) peroxisome proliferator activated receptor alpha. NCBI Reference Sequence: NP_001158347.1]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-jmPPARa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3115, + "assayComponentEndpointName": "ATG_zfPPARa_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfPPARa_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARa. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "GW7647", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2868, + "assayComponentName": "ATG_zfPPARa_EcoTox2", + "assayComponentDesc": "ATG_zfPPARa_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element zfPPARg, which is responsive to the zebrafish (Danio rerio) peroxisome proliferator activated receptor alpha. NCBI Reference Sequence: NP_001154805.1]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfPPARa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3117, + "assayComponentEndpointName": "ATG_hPPARg_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hPPARg_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARg. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Rosiglitazone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2869, + "assayComponentName": "ATG_hPPARg_EcoTox2", + "assayComponentDesc": "ATG_hPPARg_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element hPPARg, which is responsive to the human peroxisome proliferator activated receptor gamma. [NCBI Reference Sequence: NP_001341595.1]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-hPPARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3119, + "assayComponentEndpointName": "ATG_frPPARg_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frPPARg_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARg. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2870, + "assayComponentName": "ATG_frPPARg_EcoTox2", + "assayComponentDesc": "ATG_frPPARg_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element frPPARg, which is responsive to the african clawed frog (Xenopus laevis) peroxisome proliferator activated receptor gamma. [NCBI Reference Sequence: NP_001081312.1]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frPPARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3121, + "assayComponentEndpointName": "ATG_rtPPARg_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_rtPPARg_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARg. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2871, + "assayComponentName": "ATG_rtPPARg_EcoTox2", + "assayComponentDesc": "ATG_rtPPARg_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element rtPPARg, which is responsive to the rainbow trout (Oncorhynchus mykiss) peroxisome proliferator activated receptor gamma. [NCBI Reference Sequence: XP_021470054.1]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-rtPPARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3123, + "assayComponentEndpointName": "ATG_jmPPARg_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_jmPPARg_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARg. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2872, + "assayComponentName": "ATG_jmPPARg_EcoTox2", + "assayComponentDesc": "ATG_jmPPARg_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element jmPPARg, which is responsive to the japanese medaka (Oryzias latipes) peroxisome proliferator activated receptor gamma. [NCBI Reference Sequence: NP_001158348.1]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-jmPPARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1945, + "assayComponentEndpointName": "ATG_M_19_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, ATG_M_19_XSP1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1872, + "assayComponentName": "ATG_M_19_XSP1", + "assayComponentDesc": "ATG_M_19_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_19, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M19 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1947, + "assayComponentEndpointName": "ATG_M_32_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, ATG_M_32_XSP1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1873, + "assayComponentName": "ATG_M_32_XSP1", + "assayComponentDesc": "ATG_M_32_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_32, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M32 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1949, + "assayComponentEndpointName": "ATG_M_61_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, ATG_M_61_XSP1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1874, + "assayComponentName": "ATG_M_61_XSP1", + "assayComponentDesc": "ATG_M_61_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_61, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M61 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1951, + "assayComponentEndpointName": "ATG_hPPARg_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hPPARg_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARg. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1875, + "assayComponentName": "ATG_hPPARg_XSP1", + "assayComponentDesc": "ATG_hPPARg_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element PPARg, which is responsive to the human peroxisome proliferator activated receptor gamma. [GeneSymbol:PPARG | GeneID: 5468| Uniprot_SwissProt_Accession:P37231].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-PPARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 250, + "geneName": "peroxisome proliferator-activated receptor gamma", + "description": null, + "geneSymbol": "PPARG", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5468, + "officialSymbol": "PPARG", + "officialFullName": "peroxisome proliferator-activated receptor gamma", + "uniprotAccessionNumber": "P37231" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1953, + "assayComponentEndpointName": "ATG_mPPARg_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_mPPARg_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARg. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1876, + "assayComponentName": "ATG_mPPARg_XSP1", + "assayComponentDesc": "ATG_mPPARg_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element PPARg, which is responsive to the mouse peroxisome proliferator activated receptor gamma. [GeneSymbol:Pparg | GeneID: 19016| Uniprot_SwissProt_Accession:P37238].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-mPPARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1478, + "geneName": "peroxisome proliferator activated receptor gamma", + "description": "peroxisome proliferator activated receptor gamma [ Mus musculus(house mouse) ]", + "geneSymbol": "Pparg", + "organismId": 2, + "trackStatus": null, + "entrezGeneId": 19016, + "officialSymbol": "Pparg", + "officialFullName": "peroxisome proliferator activated receptor gamma", + "uniprotAccessionNumber": "P37238" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1955, + "assayComponentEndpointName": "ATG_zfPPARg_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfPPARg_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARg. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1877, + "assayComponentName": "ATG_zfPPARg_XSP1", + "assayComponentDesc": "ATG_zfPPARg_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element PPARg, which is responsive to the zebrafish peroxisome proliferator activated receptor gamma. [GeneSymbol: pparg | GeneID: 557037| Uniprot_SwissProt_Accession:A6XMH6].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfPPARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1471, + "geneName": "peroxisome proliferator-activated receptor gamma", + "description": "peroxisome proliferator-activated receptor gamma [ Danio rerio(zebrafish) ]", + "geneSymbol": "pparg", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 557037, + "officialSymbol": "pparg", + "officialFullName": "peroxisome proliferator-activated receptor gamma", + "uniprotAccessionNumber": "A6XMH6" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1957, + "assayComponentEndpointName": "ATG_mPXR_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_mPXR_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PXR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1878, + "assayComponentName": "ATG_mPXR_XSP1", + "assayComponentDesc": "ATG_mPXR_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element PXR, which is responsive to the mouse pregnane X receptor. [GeneSymbol: NR1IA | GeneID: 8856| Uniprot_SwissProt_Accession:O75469].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "NA", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 350, + "geneName": "nuclear receptor subfamily 1, group I, member 2", + "description": null, + "geneSymbol": "NR1I2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8856, + "officialSymbol": "NR1I2", + "officialFullName": "nuclear receptor subfamily 1, group I, member 2", + "uniprotAccessionNumber": "O75469" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1959, + "assayComponentEndpointName": "ATG_frTRa_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frTRa_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1879, + "assayComponentName": "ATG_frTRa_XSP1", + "assayComponentDesc": "ATG_frTRa_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element TRa, which is responsive to the frog thyroid hormone receptor, alpha L homeolog. [GeneSymbol: thra.L | GeneID: 397942| Uniprot_SwissProt_Accession: P15204].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frTRa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1482, + "geneName": "thyroid hormone receptor, alpha L homeolog", + "description": "thyroid hormone receptor, alpha L homeolog [ Xenopus laevis(African clawed frog) ]", + "geneSymbol": "thra.L", + "organismId": 46, + "trackStatus": null, + "entrezGeneId": 397942, + "officialSymbol": "thra.L", + "officialFullName": "thyroid hormone receptor, alpha L homeolog", + "uniprotAccessionNumber": "P15204" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1961, + "assayComponentEndpointName": "ATG_hTRa_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hTRa_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1880, + "assayComponentName": "ATG_hTRa_XSP1", + "assayComponentDesc": "ATG_hTRa_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element TRa, which is responsive to the human thyroid hormone receptor, alpha. [GeneSymbol: THRA | GeneID: 7067| Uniprot_SwissProt_Accession: P10827].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-TRa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 321, + "geneName": "thyroid hormone receptor, alpha", + "description": null, + "geneSymbol": "THRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7067, + "officialSymbol": "THRA", + "officialFullName": "thyroid hormone receptor, alpha", + "uniprotAccessionNumber": "P10827" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1963, + "assayComponentEndpointName": "ATG_trTRa_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_trTRa_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1881, + "assayComponentName": "ATG_trTRa_XSP1", + "assayComponentDesc": "ATG_trTRa_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element TRa, which is responsive to the turtle thyroid hormone receptor, alpha. [GeneSymbol: THRA | GeneID: 101949057| Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-trTRa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1466, + "geneName": "thyroid hormone receptor, alpha", + "description": "thyroid hormone receptor, alpha [ Chrysemys picta (painted turtle) ]", + "geneSymbol": "THRA", + "organismId": 42, + "trackStatus": null, + "entrezGeneId": 101949057, + "officialSymbol": "NA", + "officialFullName": "NA", + "uniprotAccessionNumber": "NA" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1965, + "assayComponentEndpointName": "ATG_zfTRa_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfTRa_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1882, + "assayComponentName": "ATG_zfTRa_XSP1", + "assayComponentDesc": "ATG_zfTRa_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element TRa, which is responsive to the zebrafish thyroid hormone receptor, alpha a. [GeneSymbol: thraa | GeneID: 30670| Uniprot_SwissProt_Accession: Q98867].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfTRa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1472, + "geneName": "thyroid hormone receptor alpha a", + "description": "thyroid hormone receptor alpha a [ Danio rerio (zebrafish) ]", + "geneSymbol": "thraa", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 30670, + "officialSymbol": "thraa", + "officialFullName": "thyroid hormone receptor alpha a", + "uniprotAccessionNumber": "Q98867" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1967, + "assayComponentEndpointName": "ATG_hTRb_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hTRb_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1883, + "assayComponentName": "ATG_hTRb_XSP1", + "assayComponentDesc": "ATG_hTRb_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element TRa, which is responsive to the human thyroid hormone receptor, beta. [GeneSymbol: THRB | GeneID: 7068| Uniprot_SwissProt_Accession: P10828].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-TRb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 322, + "geneName": "thyroid hormone receptor, beta", + "description": null, + "geneSymbol": "THRB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7068, + "officialSymbol": "THRB", + "officialFullName": "thyroid hormone receptor, beta", + "uniprotAccessionNumber": "P10828" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1969, + "assayComponentEndpointName": "ATG_zfTRb_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfTRb_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1884, + "assayComponentName": "ATG_zfTRb_XSP1", + "assayComponentDesc": "ATG_zfTRb_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element TRa, which is responsive to the zebrafish thyroid hormone receptor, beta. [GeneSymbol: thrb | GeneID: 30607| Uniprot_SwissProt_Accession: Q9PVE4].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfTRb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1473, + "geneName": "thyroid hormone receptor beta", + "description": "thyroid hormone receptor beta [ Danio rerio (zebrafish) ]", + "geneSymbol": "thrb", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 30607, + "officialSymbol": "thrb", + "officialFullName": "thyroid hormone receptor beta", + "uniprotAccessionNumber": "Q9PVE4" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1971, + "assayComponentEndpointName": "ATG_XTT_Cytotoxicity_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, ATG_XTT_Cytotoxicity_XSP1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in the viability. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1885, + "assayComponentName": "ATG_XTT_Cytotoxicity_XSP1", + "assayComponentDesc": "ATG_XTT_Cytotoxicity_XSP1 is an assay component measured from the ATG_XSP1_XTT_Cytotoxicity_multi-species assay. It is designed to make measurements of cell number, a form of viability reporter, as detected with fluorescence intensity signals by XTT cytotoxicity assay technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction involving the key substrate [XTT reagent] are correlated to the viability of the mitochondria in the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell number", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence Intensity", + "detectionTechnology": "XTT cytotoxicity assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "XTT reagent", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 570, + "assayName": "ATG_XSP1_XTT_Cytotoxicity_multi-species", + "assayDesc": "ATG_XSP1_XTT_Cytotoxicity_multi-species is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1973, + "assayComponentEndpointName": "ATG_M_06_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, ATG_M_06_XSP2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1886, + "assayComponentName": "ATG_M_06_XSP2", + "assayComponentDesc": "ATG_M_06_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_06, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M06 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1014, + "assayComponentEndpointName": "LTEA_HepaRG_GADD45G", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_GADD45G was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_GADD45G, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the mutagenicity response intended target family, where the subfamily is Cell proliferation, survival, death.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "mutagenicity response", + "intendedTargetFamilySub": "Cell proliferation, survival, death", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 648, + "assayComponentName": "LTEA_HepaRG_GADD45G", + "assayComponentDesc": "LTEA_HepaRG_GADD45G is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 369, + "geneName": "growth arrest and DNA-damage-inducible, gamma", + "description": null, + "geneSymbol": "GADD45G", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10912, + "officialSymbol": "GADD45G", + "officialFullName": "growth arrest and DNA-damage-inducible, gamma", + "uniprotAccessionNumber": "O95257" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1016, + "assayComponentEndpointName": "LTEA_HepaRG_GCLC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_GCLC was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_GCLC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ligase intended target family, where the subfamily is C-N ligase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "ligase", + "intendedTargetFamilySub": "C-N ligase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 649, + "assayComponentName": "LTEA_HepaRG_GCLC", + "assayComponentDesc": "LTEA_HepaRG_GCLC is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Oxidative Stress.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 142, + "geneName": "glutamate-cysteine ligase, catalytic subunit", + "description": null, + "geneSymbol": "GCLC", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2729, + "officialSymbol": "GCLC", + "officialFullName": "glutamate-cysteine ligase, catalytic subunit", + "uniprotAccessionNumber": "P48506" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1018, + "assayComponentEndpointName": "LTEA_HepaRG_GCLM", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_GCLM was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_GCLM, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ligase intended target family, where the subfamily is C-N ligase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "ligase", + "intendedTargetFamilySub": "C-N ligase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 650, + "assayComponentName": "LTEA_HepaRG_GCLM", + "assayComponentDesc": "LTEA_HepaRG_GCLM is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 143, + "geneName": "glutamate-cysteine ligase, modifier subunit", + "description": null, + "geneSymbol": "GCLM", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2730, + "officialSymbol": "GCLM", + "officialFullName": "glutamate-cysteine ligase, modifier subunit", + "uniprotAccessionNumber": "P48507" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1026, + "assayComponentEndpointName": "LTEA_HepaRG_GSTA2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_GSTA2 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_GSTA2, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where the subfamily is alkyl and aryl transferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "alkyl and aryl transferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 654, + "assayComponentName": "LTEA_HepaRG_GSTA2", + "assayComponentDesc": "LTEA_HepaRG_GSTA2 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Oxidative Stress.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 147, + "geneName": "glutathione S-transferase alpha 2", + "description": null, + "geneSymbol": "GSTA2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2939, + "officialSymbol": "GSTA2", + "officialFullName": "glutathione S-transferase alpha 2", + "uniprotAccessionNumber": "P09210" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1028, + "assayComponentEndpointName": "LTEA_HepaRG_GSTM3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_GSTM3 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_GSTM3, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where the subfamily is alkyl and aryl transferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "alkyl and aryl transferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 655, + "assayComponentName": "LTEA_HepaRG_GSTM3", + "assayComponentDesc": "LTEA_HepaRG_GSTM3 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Oxidative Stress.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 148, + "geneName": "glutathione S-transferase mu 3 (brain)", + "description": null, + "geneSymbol": "GSTM3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2947, + "officialSymbol": "GSTM3", + "officialFullName": "glutathione S-transferase mu 3 (brain)", + "uniprotAccessionNumber": "P21266" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1030, + "assayComponentEndpointName": "LTEA_HepaRG_HGF", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_HGF was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_HGF, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the growth factor intended target family, where the subfamily is hepatocyte growth factor.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "growth factor", + "intendedTargetFamilySub": "hepatocyte growth factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 656, + "assayComponentName": "LTEA_HepaRG_HGF", + "assayComponentDesc": "LTEA_HepaRG_HGF is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 151, + "geneName": "hepatocyte growth factor (hepapoietin A; scatter factor)", + "description": null, + "geneSymbol": "HGF", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3082, + "officialSymbol": "HGF", + "officialFullName": "hepatocyte growth factor (hepapoietin A; scatter factor)", + "uniprotAccessionNumber": "P14210" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1032, + "assayComponentEndpointName": "LTEA_HepaRG_HIF1A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_HIF1A was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_HIF1A, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic helix-loop-helix protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic helix-loop-helix protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 657, + "assayComponentName": "LTEA_HepaRG_HIF1A", + "assayComponentDesc": "LTEA_HepaRG_HIF1A is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 152, + "geneName": "hypoxia inducible factor 1, alpha subunit (basic helix-loop-helix transcription factor)", + "description": null, + "geneSymbol": "HIF1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3091, + "officialSymbol": "HIF1A", + "officialFullName": "hypoxia inducible factor 1, alpha subunit (basic helix-loop-helix transcription factor)", + "uniprotAccessionNumber": "Q16665" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1034, + "assayComponentEndpointName": "LTEA_HepaRG_HMGCS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_HMGCS2 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_HMGCS2, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the lyase intended target family, where the subfamily is HMG-CoA synthase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "lyase", + "intendedTargetFamilySub": "HMG-CoA synthase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 658, + "assayComponentName": "LTEA_HepaRG_HMGCS2", + "assayComponentDesc": "LTEA_HepaRG_HMGCS2 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 154, + "geneName": "3-hydroxy-3-methylglutaryl-CoA synthase 2 (mitochondrial)", + "description": null, + "geneSymbol": "HMGCS2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3158, + "officialSymbol": "HMGCS2", + "officialFullName": "3-hydroxy-3-methylglutaryl-CoA synthase 2 (mitochondrial)", + "uniprotAccessionNumber": "P54868" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1036, + "assayComponentEndpointName": "LTEA_HepaRG_HSPA1A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_HSPA1A was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_HSPA1A, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is heat shock protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "heat shock protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 659, + "assayComponentName": "LTEA_HepaRG_HSPA1A", + "assayComponentDesc": "LTEA_HepaRG_HSPA1A is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Oxidative Stress.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 162, + "geneName": "heat shock 70kDa protein 1A", + "description": null, + "geneSymbol": "HSPA1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3303, + "officialSymbol": "HSPA1A", + "officialFullName": "heat shock 70kDa protein 1A", + "uniprotAccessionNumber": "P08107" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1038, + "assayComponentEndpointName": "LTEA_HepaRG_ICAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_ICAM1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_ICAM1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is Immunoglobulin CAM.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 660, + "assayComponentName": "LTEA_HepaRG_ICAM1", + "assayComponentDesc": "LTEA_HepaRG_ICAM1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Fibrosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 170, + "geneName": "intercellular adhesion molecule 1", + "description": null, + "geneSymbol": "ICAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3383, + "officialSymbol": "ICAM1", + "officialFullName": "intercellular adhesion molecule 1", + "uniprotAccessionNumber": "P05362" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1040, + "assayComponentEndpointName": "LTEA_HepaRG_IGF1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_IGF1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_IGF1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the growth factor intended target family, where the subfamily is insulin-like.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "growth factor", + "intendedTargetFamilySub": "insulin-like", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 661, + "assayComponentName": "LTEA_HepaRG_IGF1", + "assayComponentDesc": "LTEA_HepaRG_IGF1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 171, + "geneName": "insulin-like growth factor 1 (somatomedin C)", + "description": null, + "geneSymbol": "IGF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3479, + "officialSymbol": "IGF1", + "officialFullName": "insulin-like growth factor 1 (somatomedin C)", + "uniprotAccessionNumber": "P05019" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1042, + "assayComponentEndpointName": "LTEA_HepaRG_IGFBP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_IGFBP1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_IGFBP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is hormone carrier protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "hormone carrier protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 662, + "assayComponentName": "LTEA_HepaRG_IGFBP1", + "assayComponentDesc": "LTEA_HepaRG_IGFBP1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 173, + "geneName": "insulin-like growth factor binding protein 1", + "description": null, + "geneSymbol": "IGFBP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3484, + "officialSymbol": "IGFBP1", + "officialFullName": "insulin-like growth factor binding protein 1", + "uniprotAccessionNumber": "P08833" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1044, + "assayComponentEndpointName": "LTEA_HepaRG_IL6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_IL6 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_IL6, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is interleukins.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 663, + "assayComponentName": "LTEA_HepaRG_IL6", + "assayComponentDesc": "LTEA_HepaRG_IL6 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Inflammation.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 175, + "geneName": "interleukin 6", + "description": null, + "geneSymbol": "IL6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3569, + "officialSymbol": "IL6", + "officialFullName": "interleukin 6", + "uniprotAccessionNumber": "P05231" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1046, + "assayComponentEndpointName": "LTEA_HepaRG_IL6R", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_IL6R was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_IL6R, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine receptor intended target family, where the subfamily is JAK-STAT cytokine receptor.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cytokine receptor", + "intendedTargetFamilySub": "JAK-STAT cytokine receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 664, + "assayComponentName": "LTEA_HepaRG_IL6R", + "assayComponentDesc": "LTEA_HepaRG_IL6R is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Inflammation.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 176, + "geneName": "interleukin 6 receptor", + "description": null, + "geneSymbol": "IL6R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3570, + "officialSymbol": "IL6R", + "officialFullName": "interleukin 6 receptor", + "uniprotAccessionNumber": "P08887" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1048, + "assayComponentEndpointName": "LTEA_HepaRG_JUN", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_JUN was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_JUN, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 665, + "assayComponentName": "LTEA_HepaRG_JUN", + "assayComponentDesc": "LTEA_HepaRG_JUN is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 183, + "geneName": "jun proto-oncogene", + "description": null, + "geneSymbol": "JUN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3725, + "officialSymbol": "JUN", + "officialFullName": "jun proto-oncogene", + "uniprotAccessionNumber": "P05412" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1050, + "assayComponentEndpointName": "LTEA_HepaRG_KCNK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_KCNK1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_KCNK1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is potassium channel.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "potassium channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 666, + "assayComponentName": "LTEA_HepaRG_KCNK1", + "assayComponentDesc": "LTEA_HepaRG_KCNK1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Hyperplasia.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 185, + "geneName": "potassium channel, subfamily K, member 1", + "description": null, + "geneSymbol": "KCNK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3775, + "officialSymbol": "KCNK1", + "officialFullName": "potassium channel, subfamily K, member 1", + "uniprotAccessionNumber": "O00180" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1052, + "assayComponentEndpointName": "LTEA_HepaRG_KRT19", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_KRT19 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_KRT19, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the filaments intended target family, where the subfamily is keratin.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "filaments", + "intendedTargetFamilySub": "keratin", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 667, + "assayComponentName": "LTEA_HepaRG_KRT19", + "assayComponentDesc": "LTEA_HepaRG_KRT19 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 187, + "geneName": "keratin 19", + "description": null, + "geneSymbol": "KRT19", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3880, + "officialSymbol": "KRT19", + "officialFullName": "keratin 19", + "uniprotAccessionNumber": "P08727" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1054, + "assayComponentEndpointName": "LTEA_HepaRG_LIPC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_LIPC was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_LIPC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is lipase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "lipase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 668, + "assayComponentName": "LTEA_HepaRG_LIPC", + "assayComponentDesc": "LTEA_HepaRG_LIPC is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 192, + "geneName": "lipase, hepatic", + "description": null, + "geneSymbol": "LIPC", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3990, + "officialSymbol": "LIPC", + "officialFullName": "lipase, hepatic", + "uniprotAccessionNumber": "P11150" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1056, + "assayComponentEndpointName": "LTEA_HepaRG_LPL", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_LPL was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_LPL, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is lipase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "lipase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 669, + "assayComponentName": "LTEA_HepaRG_LPL", + "assayComponentDesc": "LTEA_HepaRG_LPL is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 194, + "geneName": "lipoprotein lipase", + "description": null, + "geneSymbol": "LPL", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4023, + "officialSymbol": "LPL", + "officialFullName": "lipoprotein lipase", + "uniprotAccessionNumber": "P06858" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1058, + "assayComponentEndpointName": "LTEA_HepaRG_MIR122", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_MIR122 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_MIR122, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the microrna intended target family, where the subfamily is post-transcriptional regulation.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "miRNA", + "intendedTargetFamily": "microrna", + "intendedTargetFamilySub": "post-transcriptional regulation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 670, + "assayComponentName": "LTEA_HepaRG_MIR122", + "assayComponentDesc": "LTEA_HepaRG_MIR122 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of MicroRNA.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 457, + "geneName": "microRNA 122", + "description": null, + "geneSymbol": "MIR122", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 406906, + "officialSymbol": "MIR122", + "officialFullName": "microRNA 122", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1060, + "assayComponentEndpointName": "LTEA_HepaRG_MMP10", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_MMP10 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_MMP10, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metalloproteinase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 671, + "assayComponentName": "LTEA_HepaRG_MMP10", + "assayComponentDesc": "LTEA_HepaRG_MMP10 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Fibrosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 208, + "geneName": "matrix metallopeptidase 10 (stromelysin 2)", + "description": null, + "geneSymbol": "MMP10", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4319, + "officialSymbol": "MMP10", + "officialFullName": "matrix metallopeptidase 10 (stromelysin 2)", + "uniprotAccessionNumber": "P09238" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1062, + "assayComponentEndpointName": "LTEA_HepaRG_MMP3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_MMP3 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_MMP3, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metalloproteinase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 672, + "assayComponentName": "LTEA_HepaRG_MMP3", + "assayComponentDesc": "LTEA_HepaRG_MMP3 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Fibrosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 205, + "geneName": "matrix metallopeptidase 3 (stromelysin 1, progelatinase)", + "description": null, + "geneSymbol": "MMP3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4314, + "officialSymbol": "MMP3", + "officialFullName": "matrix metallopeptidase 3 (stromelysin 1, progelatinase)", + "uniprotAccessionNumber": "P08254" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1064, + "assayComponentEndpointName": "LTEA_HepaRG_MYC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_MYC was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_MYC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic helix-loop-helix leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic helix-loop-helix leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 673, + "assayComponentName": "LTEA_HepaRG_MYC", + "assayComponentDesc": "LTEA_HepaRG_MYC is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 213, + "geneName": "v-myc avian myelocytomatosis viral oncogene homolog", + "description": null, + "geneSymbol": "MYC", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4609, + "officialSymbol": "MYC", + "officialFullName": "v-myc avian myelocytomatosis viral oncogene homolog", + "uniprotAccessionNumber": "P01106" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1066, + "assayComponentEndpointName": "LTEA_HepaRG_NFE2L2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_NFE2L2 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_NFE2L2, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 674, + "assayComponentName": "LTEA_HepaRG_NFE2L2", + "assayComponentDesc": "LTEA_HepaRG_NFE2L2 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Inflammation/injury.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 217, + "geneName": "nuclear factor, erythroid 2-like 2", + "description": null, + "geneSymbol": "NFE2L2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4780, + "officialSymbol": "NFE2L2", + "officialFullName": "nuclear factor, erythroid 2-like 2", + "uniprotAccessionNumber": "Q16236" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1068, + "assayComponentEndpointName": "LTEA_HepaRG_NFKB1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_NFKB1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_NFKB1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is NF-kappa B.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "NF-kappa B", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 675, + "assayComponentName": "LTEA_HepaRG_NFKB1", + "assayComponentDesc": "LTEA_HepaRG_NFKB1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 218, + "geneName": "nuclear factor of kappa light polypeptide gene enhancer in B-cells 1", + "description": null, + "geneSymbol": "NFKB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4790, + "officialSymbol": "NFKB1", + "officialFullName": "nuclear factor of kappa light polypeptide gene enhancer in B-cells 1", + "uniprotAccessionNumber": "P19838" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1070, + "assayComponentEndpointName": "LTEA_HepaRG_NQO1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_NQO1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_NQO1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is quinone-acceptor.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "quinone-acceptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 676, + "assayComponentName": "LTEA_HepaRG_NQO1", + "assayComponentDesc": "LTEA_HepaRG_NQO1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Diseases associated with NQO1 include Tardive Dyskinesia and Childhood Leukemia. .", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 98, + "geneName": "NAD(P)H dehydrogenase, quinone 1", + "description": null, + "geneSymbol": "NQO1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1728, + "officialSymbol": "NQO1", + "officialFullName": "NAD(P)H dehydrogenase, quinone 1", + "uniprotAccessionNumber": "P15559" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 3125, + "assayComponentEndpointName": "ATG_zfPPARg_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfPPARg_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARg. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Triphenyl phosphate", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2873, + "assayComponentName": "ATG_zfPPARg_EcoTox2", + "assayComponentDesc": "ATG_zfPPARg_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element PPARg, which is responsive to the zebrafish (Danio rerio) peroxisome proliferator activated receptor gamma. [GeneSymbol: pparg | GeneID: 557037| Uniprot_SwissProt_Accession:A6XMH6 | NCBI Reference Sequence: NP_571542.1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfPPARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3127, + "assayComponentEndpointName": "ATG_hRXRb_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hRXRb_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RXRb. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Bexarotene", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2874, + "assayComponentName": "ATG_hRXRb_EcoTox2", + "assayComponentDesc": "ATG_hRXRb_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element hRXRb, also known as human retinoid X receptor, beta [GeneSymbol:RXRB | GeneID:6257 | Uniprot_SwissProt_Accession:P28702 |NCBI Reference Sequence: NP_068811.1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-hRXRb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3129, + "assayComponentEndpointName": "ATG_frRXRb_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frRXRb_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RXRb. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Bexarotene", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2875, + "assayComponentName": "ATG_frRXRb_EcoTox2", + "assayComponentDesc": "ATG_frRXRb_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element frRXRb, also known as african clawed frog (Xenopus laevis) retinoid X receptor, beta [NCBI Reference Sequence: NP_001080936.1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frRXRb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3131, + "assayComponentEndpointName": "ATG_rtRXRb_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_rtRXRb_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RXRb. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Bexarotene", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2876, + "assayComponentName": "ATG_rtRXRb_EcoTox2", + "assayComponentDesc": "ATG_rtRXRb_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element rtRXRb, also known as rainbow trout (Oncorhynchus mykiss) retinoid X receptor, beta [NCBI Reference Sequence: XP_021427688.1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-rtRXRb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3133, + "assayComponentEndpointName": "ATG_jmRXRb_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_jmRXRb_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RXRb. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Bexarotene", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2877, + "assayComponentName": "ATG_jmRXRb_EcoTox2", + "assayComponentDesc": "ATG_jmRXRb_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element jmRXRb, also known as japanese medaka (Oryzias latipes) retinoid X receptor, beta [NCBI Reference Sequence: XP_020562828.1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-jmRXRb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3135, + "assayComponentEndpointName": "ATG_zfRXRb_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfRXRb_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RXRb. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Bexarotene", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2878, + "assayComponentName": "ATG_zfRXRb_EcoTox2", + "assayComponentDesc": "ATG_zfRXRb_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element zfRXRb, also known as zebrafish (Danio rerio) retinoid X receptor, beta [NCBI Reference Sequence: NP_571350.1 ].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfRXRb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3137, + "assayComponentEndpointName": "ATG_hERa_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hERa_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2879, + "assayComponentName": "ATG_hERa_EcoTox2", + "assayComponentDesc": "ATG_hERa_EcoTox2 is one of 29 assay components measured or calculated from the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element hER, which is responsive to the human estrogen receptor. [GeneSymbol:ESR1 | GeneID: 2099| Uniprot_SwissProt_Accession:P03372 | NCBI Reference Sequence: NP_000116.2].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-ERa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3139, + "assayComponentEndpointName": "ATG_zfER1_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfER1_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2880, + "assayComponentName": "ATG_zfER1_EcoTox2", + "assayComponentDesc": "ATG_zfER1_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element zfER, which is responsive to the zebrafish (Danio rerio) estrogen receptor. [GeneSymbol:esr1 | GeneID: 259252| Uniprot_SwissProt_Accession:P57717 | NCBI Reference Sequence: NP_694491.1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfER1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3141, + "assayComponentEndpointName": "ATG_frER1_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frER1_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2881, + "assayComponentName": "ATG_frER1_EcoTox2", + "assayComponentDesc": "ATG_frER1_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the african clawed frog (Xenopus laevis) estrogen receptor. [GeneSymbol:esr1.L | GeneID: 398734 | Uniprot_SwissProt_Accession:Q6W5G7 | NCBI Reference Sequence: NP_001083086.1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frER1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3143, + "assayComponentEndpointName": "ATG_hAR_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hAR_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "11-keto Testosterone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2882, + "assayComponentName": "ATG_hAR_EcoTox2", + "assayComponentDesc": "ATG_hAR_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element AR, which is responsive to the human androgen receptor. [GeneSymbol:AR | GeneID:367 | Uniprot_SwissProt_Accession:P10275 | NCBI Reference Sequence: NP_000035.2].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-AR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3145, + "assayComponentEndpointName": "ATG_zfAR_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfAR_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "11-keto Testosterone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2883, + "assayComponentName": "ATG_zfAR_EcoTox2", + "assayComponentDesc": "ATG_zfAR_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element AR, which is responsive to the zebrafish (Danio rerio) androgen receptor. [GeneSymbol:AR | GeneID:100005148 | NCBI Reference Sequence: NP_001076592.1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfAR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3147, + "assayComponentEndpointName": "ATG_M_61_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_M_61_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2884, + "assayComponentName": "ATG_M_61_EcoTox2", + "assayComponentDesc": "ATG_M_61_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_61, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M61 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3149, + "assayComponentEndpointName": "ATG_M_06_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_M_06_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2885, + "assayComponentName": "ATG_M_06_EcoTox2", + "assayComponentDesc": "ATG_M_06_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_06, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M06 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3151, + "assayComponentEndpointName": "ATG_M_32_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_M_32_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2886, + "assayComponentName": "ATG_M_32_EcoTox2", + "assayComponentDesc": "ATG_M_32_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_32, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M32 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3153, + "assayComponentEndpointName": "ATG_M_19_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_M_19_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2887, + "assayComponentName": "ATG_M_19_EcoTox2", + "assayComponentDesc": "ATG_M_19_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_19, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M19 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3155, + "assayComponentEndpointName": "ATG_hGR_EcoTox2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hGR_EcoTox2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene for glucocorticoid receptor. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Dexamethasone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2859, + "assayComponentName": "ATG_hGR_EcoTox2", + "assayComponentDesc": "ATG_hGR_EcoTox2 is one of 29 assay components calculated in the ATG_EcoTox2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element hGR, also known as human glucocorticoid receptor isoform alpha. [NCBI Reference Sequence: NP_000167.1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-GR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 876, + "assayName": "ATG_EcoTox2", + "assayDesc": "ATG_EcoTox2 is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), african clawed frog (Xenopus laevis), rainbow trout (Oncorhynchus mykiss), japanese medaka (Oryzias latipes), and zebrafish (Danio rerio). The ECOTOX2-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3161, + "assayComponentEndpointName": "CCTE_Deisenroth_H295R-HTRF_384WELL_ESTRADIOL", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, CCTE_Deisenroth_H295R-HTRF_384WELL_ESTRADIOL, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using Homogenous Time Resolved Fluorescence technology was used to understand synthesis of estradiol in the H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is estrogens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "fold_induction", + "burstAssay": 0, + "keyPositiveControl": "forskolin for gain; prochloraz for loss", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "estradiol", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "estrogens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2891, + "assayComponentName": "CCTE_Deisenroth_H295R-HTRF_384WELL_ESTRADIOL", + "assayComponentDesc": "CCTE_Deisenroth_H295R-HTRF_384WELL_ESTRADIOL is one of 3 assay components calculated in the CCTE_Deisenroth_H295R-HTRF_384WELL assay (2 hormones and 1 viability components). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with Homogenous Time Resolved Fluorescence immunoassay technology.", + "assayComponentTargetDesc": "Changes in the fluorescence ratio are indicative of induction (gain of signal) or inhibition (loss of signal) of steroid hormone biosynthesis.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence ratio", + "detectionTechnology": "Homogenous Time Resolved Fluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "estradiol", + "aid": 879, + "assayName": "CCTE_Deisenroth_H295R-HTRF_384WELL", + "assayDesc": "CCTE_Deisenroth_H295R-HTRF_384WELL assay is a cell-based, multiplex-readout assay that uses H295R, a human adrenocortical carcinoma cell line, with measurements taken at 48 hours after chemical dosing in a 384-well microplate", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell-based", + "cellFreeComponentSource": "NA", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplex", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3162, + "assayComponentEndpointName": "CCTE_Deisenroth_H295R-HTRF_384WELL_TESTOSTERONE", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, CCTE_Deisenroth_H295R-HTRF_384WELL_TESTOSTERONE, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using Homogenous Time Resolved Fluorescence technology was used to understand synthesis of testosterone in the H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is androgens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "fold_induction", + "burstAssay": 0, + "keyPositiveControl": "forskolin for gain; prochloraz for loss", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "testosterone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "androgens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2892, + "assayComponentName": "CCTE_Deisenroth_H295R-HTRF_384WELL_TESTOSTERONE", + "assayComponentDesc": "CCTE_Deisenroth_H295R-HTRF_384WELL_TESTOSTERONE is one of 3 assay components calculated in the CCTE_Deisenroth_H295R-HTRF_384WELL assay (2 hormones and 1 viability components). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with Homogenous Time Resolved Fluorescence immunoassay technology.", + "assayComponentTargetDesc": "Changes in the fluorescence ratio are indicative of induction (gain of signal) or inhibition (loss of signal) of steroid hormone biosynthesis.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence ratio", + "detectionTechnology": "Homogenous Time Resolved Fluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "testosterone", + "aid": 879, + "assayName": "CCTE_Deisenroth_H295R-HTRF_384WELL", + "assayDesc": "CCTE_Deisenroth_H295R-HTRF_384WELL assay is a cell-based, multiplex-readout assay that uses H295R, a human adrenocortical carcinoma cell line, with measurements taken at 48 hours after chemical dosing in a 384-well microplate", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell-based", + "cellFreeComponentSource": "NA", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplex", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3163, + "assayComponentEndpointName": "CCTE_Deisenroth_H295R-HTRF_384WELL_CTOX", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, CCTE_Deisenroth_H295R-HTRF_384WELL_CTOX, was analyzed in the positive fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity using CellTiter-Glo 2.0 technology was used to understand viability in the H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity", + "assayFunctionType": "viability", + "normalizedDataType": "fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2893, + "assayComponentName": "CCTE_Deisenroth_H295R-HTRF_384WELL_CTOX", + "assayComponentDesc": "CCTE_Deisenroth_H295R-HTRF_384WELL_CTOX is one of 3 assay components measured in the CCTE_Deisenroth_H295R-HTRF_384WELL assay (2 hormones and 1 viability components). It is designed to make measurements of adenosine triphosphate (ATP), a form of viability reporter, as detected with luminescence intensity signals by CellTiter-Glo 2.0 cytotoxicity assay technology.", + "assayComponentTargetDesc": "Changes in luminescence intensity, proportional to the amount of ATP present, are indicative of cytotoxicity. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Luminescence intensity", + "detectionTechnology": "CellTiter-Glo 2.0", + "keyAssayReagentType": "luciferase co-factor", + "keyAssayReagent": "luciferin", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "ATP", + "aid": 879, + "assayName": "CCTE_Deisenroth_H295R-HTRF_384WELL", + "assayDesc": "CCTE_Deisenroth_H295R-HTRF_384WELL assay is a cell-based, multiplex-readout assay that uses H295R, a human adrenocortical carcinoma cell line, with measurements taken at 48 hours after chemical dosing in a 384-well microplate", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell-based", + "cellFreeComponentSource": "NA", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplex", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3164, + "assayComponentEndpointName": "CCTE_Mundy_HCI_iCellGABA_NOG_BPCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_iCellGABA_NOG_BPCount was analyzed at the endpoint CCTE_Mundy_HCI_iCellGABA_NOG_BPCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss-of-signal activity can be used to understand developmental effects. This assay component is considered less reliable by experts on the assay due to low occurrence of branch points in the iCell GABANeurons. Use data with caution.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (30uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2894, + "assayComponentName": "CCTE_Mundy_HCI_iCellGABA_NOG_BPCount", + "assayComponentDesc": "CCTE_Mundy_HCI_iCellGABA_NOG_BPCount is one of four components of the CCTE_Mundy_HCI_iCellGABA_NOG assay. It measures neurite outgrowth related to number of branch points using High Content Imaging of fluorescently labelled markers. This assay component is considered less reliable by experts on the assay due to low occurrence of branch points in the iCell GABANeurons. Use data with caution.", + "assayComponentTargetDesc": "Changes in the number of branch points are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of branch points", + "aid": 880, + "assayName": "CCTE_Mundy_HCI_iCellGABA_NOG", + "assayDesc": "CCTE_Mundy_HCI_iCellGABA_NOG is a multiplexed, cell-based-readout assay that uses iCell GABANeurons from FUJIFILM Cellular Dynamics, Inc. (FCDI), human GABAergic enriched neurons derived from induced pluripotent stem (iPS) cells, with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "secondary cell", + "cellFreeComponentSource": "human GABAergic enriched neurons derived from induced pluripotent stem (iPS) cells", + "cellShortName": "iCell GABANeurons", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3165, + "assayComponentEndpointName": "CCTE_Mundy_HCI_iCellGABA_NOG_NeuriteCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_iCellGABA_NOG_NeuriteCount was analyzed at the endpoint CCTE_Mundy_HCI_iCellGABA_NOG_NeuriteCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (30uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2895, + "assayComponentName": "CCTE_Mundy_HCI_iCellGABA_NOG_NeuriteCount", + "assayComponentDesc": "CCTE_Mundy_HCI_iCellGABA_NOG_NeuriteCount is one of four components of the CCTE_Mundy_HCI_iCellGABA_NOG assay. It measures neurite outgrowth related to number of neurites using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of neurites are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of neurites", + "aid": 880, + "assayName": "CCTE_Mundy_HCI_iCellGABA_NOG", + "assayDesc": "CCTE_Mundy_HCI_iCellGABA_NOG is a multiplexed, cell-based-readout assay that uses iCell GABANeurons from FUJIFILM Cellular Dynamics, Inc. (FCDI), human GABAergic enriched neurons derived from induced pluripotent stem (iPS) cells, with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "secondary cell", + "cellFreeComponentSource": "human GABAergic enriched neurons derived from induced pluripotent stem (iPS) cells", + "cellShortName": "iCell GABANeurons", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3166, + "assayComponentEndpointName": "CCTE_Mundy_HCI_iCellGABA_NOG_NeuriteLength", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_iCellGABA_NOG_NeuriteLength was analyzed at the endpoint CCTE_Mundy_HCI_iCellGABA_NOG_NeuriteLength in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (30uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth (initiation)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2896, + "assayComponentName": "CCTE_Mundy_HCI_iCellGABA_NOG_NeuriteLength", + "assayComponentDesc": "CCTE_Mundy_HCI_iCellGABA_NOG_NeuriteLength is one of four components of the CCTE_Mundy_HCI_iCellGABA_NOG assay. It measures neurite outgrowth related to neurite length using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the neurite length are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "neurite length", + "aid": 880, + "assayName": "CCTE_Mundy_HCI_iCellGABA_NOG", + "assayDesc": "CCTE_Mundy_HCI_iCellGABA_NOG is a multiplexed, cell-based-readout assay that uses iCell GABANeurons from FUJIFILM Cellular Dynamics, Inc. (FCDI), human GABAergic enriched neurons derived from induced pluripotent stem (iPS) cells, with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "secondary cell", + "cellFreeComponentSource": "human GABAergic enriched neurons derived from induced pluripotent stem (iPS) cells", + "cellShortName": "iCell GABANeurons", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 3167, + "assayComponentEndpointName": "CCTE_Mundy_HCI_iCellGABA_NOG_NeuronCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Mundy_HCI_iCellGABA_NOG_NeuronCount was analyzed at the endpoint CCTE_Mundy_HCI_iCellGABA_NOG_NeuronCount in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand developmental effects.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rac 1 inhibitor (30uM)", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2897, + "assayComponentName": "CCTE_Mundy_HCI_iCellGABA_NOG_NeuronCount", + "assayComponentDesc": "CCTE_Mundy_HCI_iCellGABA_NOG_NeuronCount is one of four components of the CCTE_Mundy_HCI_iCellGABA_NOG assay. It measures cell viability related to number of neurons using High Content Imaging of fluorescently labelled markers.", + "assayComponentTargetDesc": "Changes in the number of neurons are indicative of neurodevelopment.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TUBB3 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of neurons", + "aid": 880, + "assayName": "CCTE_Mundy_HCI_iCellGABA_NOG", + "assayDesc": "CCTE_Mundy_HCI_iCellGABA_NOG is a multiplexed, cell-based-readout assay that uses iCell GABANeurons from FUJIFILM Cellular Dynamics, Inc. (FCDI), human GABAergic enriched neurons derived from induced pluripotent stem (iPS) cells, with measurements taken at 50.33 hours after chemical dosing in a microplate: 96-well plate.", + "timepointHr": 50.33, + "organismId": 9606, + "organism": "human", + "tissue": "neural", + "cellFormat": "secondary cell", + "cellFreeComponentSource": "human GABAergic enriched neurons derived from induced pluripotent stem (iPS) cells", + "cellShortName": "iCell GABANeurons", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.1, + "asid": 31, + "assaySourceName": "CCTE_MUNDY", + "assaySourceLongName": "CCTE Mundy Lab", + "assaySourceDesc": "The Mundy Lab at the EPA Center for Computational Toxicology and Exposure utilizes high content imaging to characterize chemical effects in neurodevelopment.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1975, + "assayComponentEndpointName": "ATG_trERa_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_trERa_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1887, + "assayComponentName": "ATG_trERa_XSP2", + "assayComponentDesc": "ATG_trERa_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the turtle estrogen receptor. [GeneSymbol:ESR1 | GeneID: 101933533| Uniprot_SwissProt_Accession:B6E1V9].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-trERa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1465, + "geneName": "estrogen receptor 1", + "description": "estrogen receptor 1 [ Chrysemys picta (painted turtle) ]", + "geneSymbol": "ESR1", + "organismId": 42, + "trackStatus": null, + "entrezGeneId": 101933533, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "B6E1V9" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1977, + "assayComponentEndpointName": "ATG_hERb_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hERb_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1888, + "assayComponentName": "ATG_hERb_XSP2", + "assayComponentDesc": "ATG_hERb_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the human estrogen receptor. [GeneSymbol:ESR2 | GeneID: 2100| Uniprot_SwissProt_Accession:Q92731].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-ER-b RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 118, + "geneName": "estrogen receptor 2 (ER beta)", + "description": null, + "geneSymbol": "ESR2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2100, + "officialSymbol": "ESR2", + "officialFullName": "estrogen receptor 2 (ER beta)", + "uniprotAccessionNumber": "Q92731" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1979, + "assayComponentEndpointName": "ATG_trAR_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_trAR_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1889, + "assayComponentName": "ATG_trAR_XSP2", + "assayComponentDesc": "ATG_trAR_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element AR, which is responsive to the turtle androgen receptor. [GeneSymbol:AR | GeneID:101947425 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-trAR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1464, + "geneName": "androgen receptor", + "description": "PREDICTED: Chrysemys picta bellii androgen receptor (AR), mRNA", + "geneSymbol": "AR", + "organismId": 42, + "trackStatus": null, + "entrezGeneId": 101947425, + "officialSymbol": "NA", + "officialFullName": "NA", + "uniprotAccessionNumber": "NA" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1981, + "assayComponentEndpointName": "ATG_GAL4_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, ATG_GAL4_XSP2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is baseline control.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1890, + "assayComponentName": "ATG_GAL4_XSP2", + "assayComponentDesc": "ATG_GAL4_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-gal4 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 466, + "geneName": "Gal4p", + "description": "provisional", + "geneSymbol": "GAL4", + "organismId": 8, + "trackStatus": "live", + "entrezGeneId": 855828, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P04386" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1983, + "assayComponentEndpointName": "ATG_zfER1_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfER1_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1891, + "assayComponentName": "ATG_zfER1_XSP2", + "assayComponentDesc": "ATG_zfER1_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the zebrafish estrogen receptor. [GeneSymbol:esr1 | GeneID: 259252| Uniprot_SwissProt_Accession:P57717].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfER1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1468, + "geneName": "estrogen receptor 1", + "description": "estrogen receptor [Danio rerio (zebrafish)]", + "geneSymbol": "esr1", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 259252, + "officialSymbol": "esr1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P57717" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1985, + "assayComponentEndpointName": "ATG_chERa_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_chERa_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1892, + "assayComponentName": "ATG_chERa_XSP2", + "assayComponentDesc": "ATG_chERa_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the chicken estrogen receptor. [GeneSymbol:ESR1 | GeneID: 396099| Uniprot_SwissProt_Accession:P06212].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-chERa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1475, + "geneName": "estrogen receptor 1", + "description": "estrogen receptor 1 (chicken)", + "geneSymbol": "ESR1", + "organismId": 45, + "trackStatus": null, + "entrezGeneId": 396099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P06212" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1987, + "assayComponentEndpointName": "ATG_zfER2a_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfER2a_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1893, + "assayComponentName": "ATG_zfER2a_XSP2", + "assayComponentDesc": "ATG_zfER2a_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the zebrafish estrogen receptor. [GeneSymbol:esr2a | GeneID: 317734| Uniprot_SwissProt_Accession:Q7ZU32].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfER2a RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1469, + "geneName": "estrogen receptor 2a", + "description": "estrogen receptor 2a [ Danio rerio (zebrafish) ]", + "geneSymbol": "esr2a", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 317734, + "officialSymbol": "esr2a", + "officialFullName": "estrogen receptor 2a", + "uniprotAccessionNumber": "Q7ZU32" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1989, + "assayComponentEndpointName": "ATG_hAR_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hAR_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1894, + "assayComponentName": "ATG_hAR_XSP2", + "assayComponentDesc": "ATG_hAR_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element AR, which is responsive to the human androgen receptor. [GeneSymbol:AR | GeneID:367 | Uniprot_SwissProt_Accession:P10275].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-AR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1991, + "assayComponentEndpointName": "ATG_chAR_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_chAR_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1895, + "assayComponentName": "ATG_chAR_XSP2", + "assayComponentDesc": "ATG_chAR_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element AR, which is responsive to the chicken androgen receptor. [GeneSymbol:ar | GeneID:422165| Uniprot_SwissProt_Accession:Q2ACE0].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-chAR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1474, + "geneName": "androgen receptor", + "description": "androgen receptor (chicken)", + "geneSymbol": "AR", + "organismId": 45, + "trackStatus": null, + "entrezGeneId": 422165, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "Q2ACE0" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1993, + "assayComponentEndpointName": "ATG_frER1_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frER1_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1896, + "assayComponentName": "ATG_frER1_XSP2", + "assayComponentDesc": "ATG_frER1_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the frog estrogen receptor. [GeneSymbol:esr1.L | GeneID: 398734 | Uniprot_SwissProt_Accession:Q6W5G7].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frER1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1480, + "geneName": "estrogen receptor 1 L homeolog", + "description": "estrogen receptor 1 L homeolog [Xenopus laevis (African clawed frog)]", + "geneSymbol": "esr1.L", + "organismId": 46, + "trackStatus": null, + "entrezGeneId": 398734, + "officialSymbol": "esr1.L", + "officialFullName": "estrogen receptor 1 L homeolog", + "uniprotAccessionNumber": "Q6W5G7" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1995, + "assayComponentEndpointName": "ATG_frAR_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frAR_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1897, + "assayComponentName": "ATG_frAR_XSP2", + "assayComponentDesc": "ATG_frAR_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element AR, which is responsive to the frog androgen receptor. [GeneSymbol:ar.L | GeneID:399456| Uniprot_SwissProt_Accession:P70048].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frAR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1479, + "geneName": "androgen receptor L homeolog", + "description": "androgen receptor L homeolog [Xenopus laevis (African clawed frog)]", + "geneSymbol": "ar.L", + "organismId": 46, + "trackStatus": null, + "entrezGeneId": 399456, + "officialSymbol": "ar.L", + "officialFullName": "androgen receptor (dihydrotestosterone receptor; testicular feminization; spinal and bulbar muscular atrophy; Kennedy disease) L homeolog", + "uniprotAccessionNumber": "P70048" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1997, + "assayComponentEndpointName": "ATG_zfAR_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfAR_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1898, + "assayComponentName": "ATG_zfAR_XSP2", + "assayComponentDesc": "ATG_zfAR_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element AR, which is responsive to the zebrafish androgen receptor. [GeneSymbol:AR | GeneID:100005148 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfAR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1467, + "geneName": "androgen receptor", + "description": "androgen receptor [Danio rerio (zebrafish)]", + "geneSymbol": "ar", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 100005148, + "officialSymbol": "ar", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "A4GT83" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1999, + "assayComponentEndpointName": "ATG_zfER2b_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfER2b_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1899, + "assayComponentName": "ATG_zfER2b_XSP2", + "assayComponentDesc": "ATG_zfER2b_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the zebrafish estrogen receptor. [GeneSymbol:esr2b | GeneID: 317733| Uniprot_SwissProt_Accession:Q5PR29].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfER2b RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1470, + "geneName": "estrogen receptor 2b", + "description": "estrogen receptor 2b [ Danio rerio (zebrafish) ]", + "geneSymbol": "esr2b", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 317733, + "officialSymbol": "esr2b", + "officialFullName": "estrogen receptor 2b", + "uniprotAccessionNumber": "Q5PR29" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2001, + "assayComponentEndpointName": "ATG_hERa_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hERa_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1900, + "assayComponentName": "ATG_hERa_XSP2", + "assayComponentDesc": "ATG_hERa_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the human estrogen receptor. [GeneSymbol:ESR1 | GeneID: 2099| Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-ERa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2003, + "assayComponentEndpointName": "ATG_M_19_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, ATG_M_19_XSP2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1901, + "assayComponentName": "ATG_M_19_XSP2", + "assayComponentDesc": "ATG_M_19_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_19, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M19 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2005, + "assayComponentEndpointName": "ATG_M_32_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, ATG_M_32_XSP2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1902, + "assayComponentName": "ATG_M_32_XSP2", + "assayComponentDesc": "ATG_M_32_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_32, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M32 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2023, + "assayComponentEndpointName": "ATG_M_61_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, ATG_M_61_XSP2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1911, + "assayComponentName": "ATG_M_61_XSP2", + "assayComponentDesc": "ATG_M_61_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_61, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M61 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1072, + "assayComponentEndpointName": "LTEA_HepaRG_PDK4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_PDK4 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_PDK4, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 677, + "assayComponentName": "LTEA_HepaRG_PDK4", + "assayComponentDesc": "LTEA_HepaRG_PDK4 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Diseases associated with PDK4 include Platelet Glycoprotein Iv Deficiency and Diabetes Mellitus, Noninsulin-Dependent. .", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 234, + "geneName": "pyruvate dehydrogenase kinase, isozyme 4", + "description": null, + "geneSymbol": "PDK4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5166, + "officialSymbol": "PDK4", + "officialFullName": "pyruvate dehydrogenase kinase, isozyme 4", + "uniprotAccessionNumber": "Q16654" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1074, + "assayComponentEndpointName": "LTEA_HepaRG_PEG10", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_PEG10 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_PEG10, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 678, + "assayComponentName": "LTEA_HepaRG_PEG10", + "assayComponentDesc": "LTEA_HepaRG_PEG10 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 375, + "geneName": "paternally expressed 10", + "description": null, + "geneSymbol": "PEG10", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 23089, + "officialSymbol": "PEG10", + "officialFullName": "paternally expressed 10", + "uniprotAccessionNumber": "Q86TG7" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1076, + "assayComponentEndpointName": "LTEA_HepaRG_PPP2R4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_PPP2R4 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_PPP2R4, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is serine/threonine phosphatase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "serine/threonine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 679, + "assayComponentName": "LTEA_HepaRG_PPP2R4", + "assayComponentDesc": "LTEA_HepaRG_PPP2R4 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 254, + "geneName": "protein phosphatase 2A activator, regulatory subunit 4", + "description": null, + "geneSymbol": "PPP2R4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5524, + "officialSymbol": "PPP2R4", + "officialFullName": "protein phosphatase 2A activator, regulatory subunit 4", + "uniprotAccessionNumber": "Q15257" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1078, + "assayComponentEndpointName": "LTEA_HepaRG_PTEN", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_PTEN was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_PTEN, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is dual-specific phosphatase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "dual-specific phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 680, + "assayComponentName": "LTEA_HepaRG_PTEN", + "assayComponentDesc": "LTEA_HepaRG_PTEN is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 263, + "geneName": "phosphatase and tensin homolog", + "description": null, + "geneSymbol": "PTEN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5728, + "officialSymbol": "PTEN", + "officialFullName": "phosphatase and tensin homolog", + "uniprotAccessionNumber": "P60484" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1080, + "assayComponentEndpointName": "LTEA_HepaRG_SDHB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_SDHB was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_SDHB, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is ubiquinone.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "ubiquinone", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 681, + "assayComponentName": "LTEA_HepaRG_SDHB", + "assayComponentDesc": "LTEA_HepaRG_SDHB is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 292, + "geneName": "succinate dehydrogenase complex, subunit B, iron sulfur (Ip)", + "description": null, + "geneSymbol": "SDHB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6390, + "officialSymbol": "SDHB", + "officialFullName": "succinate dehydrogenase complex, subunit B, iron sulfur (Ip)", + "uniprotAccessionNumber": "P21912" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1082, + "assayComponentEndpointName": "LTEA_HepaRG_SLC22A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_SLC22A1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_SLC22A1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is organic cation transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "organic cation transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 682, + "assayComponentName": "LTEA_HepaRG_SLC22A1", + "assayComponentDesc": "LTEA_HepaRG_SLC22A1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated transport.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 300, + "geneName": "solute carrier family 22 (organic cation transporter), member 1", + "description": null, + "geneSymbol": "SLC22A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6580, + "officialSymbol": "SLC22A1", + "officialFullName": "solute carrier family 22 (organic cation transporter), member 1", + "uniprotAccessionNumber": "O15245" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1084, + "assayComponentEndpointName": "LTEA_HepaRG_SLCO1B1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_SLCO1B1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_SLCO1B1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is organic anion transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "organic anion transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 683, + "assayComponentName": "LTEA_HepaRG_SLCO1B1", + "assayComponentDesc": "LTEA_HepaRG_SLCO1B1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated transport.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 367, + "geneName": "solute carrier organic anion transporter family, member 1B1", + "description": null, + "geneSymbol": "SLCO1B1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10599, + "officialSymbol": "SLCO1B1", + "officialFullName": "solute carrier organic anion transporter family, member 1B1", + "uniprotAccessionNumber": "Q9Y6L6" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1086, + "assayComponentEndpointName": "LTEA_HepaRG_STAT3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_STAT3 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_STAT3, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is stat protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "stat protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 684, + "assayComponentName": "LTEA_HepaRG_STAT3", + "assayComponentDesc": "LTEA_HepaRG_STAT3 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 305, + "geneName": "signal transducer and activator of transcription 3 (acute-phase response factor)", + "description": null, + "geneSymbol": "STAT3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6774, + "officialSymbol": "STAT3", + "officialFullName": "signal transducer and activator of transcription 3 (acute-phase response factor)", + "uniprotAccessionNumber": "P40763" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1088, + "assayComponentEndpointName": "LTEA_HepaRG_SULT2A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_SULT2A1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_SULT2A1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where the subfamily is sulfotransferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "sulfotransferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 685, + "assayComponentName": "LTEA_HepaRG_SULT2A1", + "assayComponentDesc": "LTEA_HepaRG_SULT2A1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated transport.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 307, + "geneName": "sulfotransferase family, cytosolic, 2A, dehydroepiandrosterone (DHEA)-preferring, member 1", + "description": null, + "geneSymbol": "SULT2A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6822, + "officialSymbol": "SULT2A1", + "officialFullName": "sulfotransferase family, cytosolic, 2A, dehydroepiandrosterone (DHEA)-preferring, member 1", + "uniprotAccessionNumber": "Q06520" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1090, + "assayComponentEndpointName": "LTEA_HepaRG_TGFA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_TGFA was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_TGFA, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the growth factor intended target family, where the subfamily is EGF-like domain.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "growth factor", + "intendedTargetFamilySub": "EGF-like domain", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 686, + "assayComponentName": "LTEA_HepaRG_TGFA", + "assayComponentDesc": "LTEA_HepaRG_TGFA is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 318, + "geneName": "transforming growth factor, alpha", + "description": null, + "geneSymbol": "TGFA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7039, + "officialSymbol": "TGFA", + "officialFullName": "transforming growth factor, alpha", + "uniprotAccessionNumber": "P01135" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1092, + "assayComponentEndpointName": "LTEA_HepaRG_TGFB1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_TGFB1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_TGFB1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the growth factor intended target family, where the subfamily is transforming growth factor beta.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "growth factor", + "intendedTargetFamilySub": "transforming growth factor beta", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 687, + "assayComponentName": "LTEA_HepaRG_TGFB1", + "assayComponentDesc": "LTEA_HepaRG_TGFB1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 319, + "geneName": "transforming growth factor, beta 1", + "description": null, + "geneSymbol": "TGFB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7040, + "officialSymbol": "TGFB1", + "officialFullName": "transforming growth factor, beta 1", + "uniprotAccessionNumber": "P01137" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1094, + "assayComponentEndpointName": "LTEA_HepaRG_THRSP", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_THRSP was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_THRSP, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the growth factor intended target family, where the subfamily is NR mediated metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "growth factor", + "intendedTargetFamilySub": "NR mediated metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 688, + "assayComponentName": "LTEA_HepaRG_THRSP", + "assayComponentDesc": "LTEA_HepaRG_THRSP is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 323, + "geneName": "thyroid hormone responsive", + "description": null, + "geneSymbol": "THRSP", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7069, + "officialSymbol": "THRSP", + "officialFullName": "thyroid hormone responsive", + "uniprotAccessionNumber": "Q92748" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1096, + "assayComponentEndpointName": "LTEA_HepaRG_TIMP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_TIMP1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_TIMP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease inhibitor intended target family, where the subfamily is metalloproteinase inhibitor.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "protease inhibitor", + "intendedTargetFamilySub": "metalloproteinase inhibitor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 689, + "assayComponentName": "LTEA_HepaRG_TIMP1", + "assayComponentDesc": "LTEA_HepaRG_TIMP1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 324, + "geneName": "TIMP metallopeptidase inhibitor 1", + "description": null, + "geneSymbol": "TIMP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7076, + "officialSymbol": "TIMP1", + "officialFullName": "TIMP metallopeptidase inhibitor 1", + "uniprotAccessionNumber": "P01033" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1098, + "assayComponentEndpointName": "LTEA_HepaRG_TNFRSF1A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_TNFRSF1A was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_TNFRSF1A, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine receptor intended target family, where the subfamily is TNF receptor.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cytokine receptor", + "intendedTargetFamilySub": "TNF receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 690, + "assayComponentName": "LTEA_HepaRG_TNFRSF1A", + "assayComponentDesc": "LTEA_HepaRG_TNFRSF1A is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 328, + "geneName": "tumor necrosis factor receptor superfamily, member 1A", + "description": null, + "geneSymbol": "TNFRSF1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7132, + "officialSymbol": "TNFRSF1A", + "officialFullName": "tumor necrosis factor receptor superfamily, member 1A", + "uniprotAccessionNumber": "P19438" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1100, + "assayComponentEndpointName": "LTEA_HepaRG_TP53", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_TP53 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_TP53, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is tumor suppressor.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "tumor suppressor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 691, + "assayComponentName": "LTEA_HepaRG_TP53", + "assayComponentDesc": "LTEA_HepaRG_TP53 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Oxidative Stress.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 329, + "geneName": "tumor protein p53", + "description": null, + "geneSymbol": "TP53", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7157, + "officialSymbol": "TP53", + "officialFullName": "tumor protein p53", + "uniprotAccessionNumber": "P04637" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1102, + "assayComponentEndpointName": "LTEA_HepaRG_UGT1A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_UGT1A1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_UGT1A1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where the subfamily is glucuronosyltransferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "glucuronosyltransferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 692, + "assayComponentName": "LTEA_HepaRG_UGT1A1", + "assayComponentDesc": "LTEA_HepaRG_UGT1A1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis/NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 430, + "geneName": "UDP glucuronosyltransferase 1 family, polypeptide A1", + "description": null, + "geneSymbol": "UGT1A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 54658, + "officialSymbol": "UGT1A1", + "officialFullName": "UDP glucuronosyltransferase 1 family, polypeptide A1", + "uniprotAccessionNumber": "P22309" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1104, + "assayComponentEndpointName": "LTEA_HepaRG_UGT1A6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_UGT1A6 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_UGT1A6, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where the subfamily is glucuronosyltransferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "glucuronosyltransferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 693, + "assayComponentName": "LTEA_HepaRG_UGT1A6", + "assayComponentDesc": "LTEA_HepaRG_UGT1A6 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 429, + "geneName": "UDP glucuronosyltransferase 1 family, polypeptide A6", + "description": null, + "geneSymbol": "UGT1A6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 54578, + "officialSymbol": "UGT1A6", + "officialFullName": "UDP glucuronosyltransferase 1 family, polypeptide A6", + "uniprotAccessionNumber": "P19224" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1106, + "assayComponentEndpointName": "LTEA_HepaRG_XBP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_XBP1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_XBP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 694, + "assayComponentName": "LTEA_HepaRG_XBP1", + "assayComponentDesc": "LTEA_HepaRG_XBP1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Diseases associated with XBP1 include Major Affective Disorder 7 and Bipolar Disorde.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 337, + "geneName": "X-box binding protein 1", + "description": null, + "geneSymbol": "XBP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7494, + "officialSymbol": "XBP1", + "officialFullName": "X-box binding protein 1", + "uniprotAccessionNumber": "P17861" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1108, + "assayComponentEndpointName": "TOX21_ARE_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ARE_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ARE_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NFE2L2. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Beta-Naphthoflavone", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 695, + "assayComponentName": "TOX21_ARE_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_ARE_BLA_Agonist_ch1 is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ARE_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target transcription factor activity, specifically mapping to NFE2L2 gene(s) using a positive control of Beta-Naphthoflavone", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 372, + "assayName": "TOX21_ARE_BLA_Agonist", + "assayDesc": "TOX21_ARE_BLA_Agonist is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1289/EHP2589", + "url": "https://pubmed.ncbi.nlm.nih.gov/30059008/", + "pmid": 30059008, + "title": "Comprehensive Analyses and Prioritization of Tox21 10K Chemicals Affecting Mitochondrial Function by in-Depth Mechanistic Studies", + "author": "Xia M, Huang R, Shi Q, Boyd WA, Zhao J, Sun N, Rice JR, Dunlap PE, Hackstadt AJ, Bridge MF, Smith MV, Dai S, Zheng W, Chu PH, Gerhold D, Witt KL, DeVito M, Freedman JH, Austin CP, Houck KA, Thomas RS, Paules RS, Tice RR, Simeonov A", + "citation": "Xia M, Huang R, Shi Q, Boyd WA, Zhao J, Sun N, Rice JR, Dunlap PE, Hackstadt AJ, Bridge MF, Smith MV, Dai S, Zheng W, Chu PH, Gerhold D, Witt KL, DeVito M, Freedman JH, Austin CP, Houck KA, Thomas RS, Paules RS, Tice RR, Simeonov A. Comprehensive Analyses and Prioritization of Tox21 10K Chemicals Affecting Mitochondrial Function by in-Depth Mechanistic Studies. Environ Health Perspect. 2018 Jul 26;126(7):077010. doi: 10.1289/EHP2589. PMID: 30059008; PMCID: PMC6112376.", + "otherId": "0", + "citationId": 275, + "otherSource": "" + } + }, + { + "aeid": 1109, + "assayComponentEndpointName": "TOX21_ARE_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ARE_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ARE_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene NFE2L2. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Beta-Naphthoflavone", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 696, + "assayComponentName": "TOX21_ARE_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_ARE_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ARE_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target transcription factor activity, specifically mapping to NFE2L2 gene(s) using a positive control of Beta-Naphthoflavone", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 372, + "assayName": "TOX21_ARE_BLA_Agonist", + "assayDesc": "TOX21_ARE_BLA_Agonist is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": " doi: 10.1289/EHP2589", + "url": "https://pubmed.ncbi.nlm.nih.gov/30059008/", + "pmid": 30059008, + "title": "Comprehensive Analyses and Prioritization of Tox21 10K Chemicals Affecting Mitochondrial Function by in-Depth Mechanistic Studies", + "author": "Xia M, Huang R, Shi Q, Boyd WA, Zhao J, Sun N, Rice JR, Dunlap PE, Hackstadt AJ, Bridge MF, Smith MV, Dai S, Zheng W, Chu PH, Gerhold D, Witt KL, DeVito M, Freedman JH, Austin CP, Houck KA, Thomas RS, Paules RS, Tice RR, Simeonov A", + "citation": "Xia M, Huang R, Shi Q, Boyd WA, Zhao J, Sun N, Rice JR, Dunlap PE, Hackstadt AJ, Bridge MF, Smith MV, Dai S, Zheng W, Chu PH, Gerhold D, Witt KL, DeVito M, Freedman JH, Austin CP, Houck KA, Thomas RS, Paules RS, Tice RR, Simeonov A. Comprehensive Analyses and Prioritization of Tox21 10K Chemicals Affecting Mitochondrial Function by in-Depth Mechanistic Studies. Environ Health Perspect. 2018 Jul 26;126(7):077010. doi: 10.1289/EHP2589. PMID: 30059008; PMCID: PMC6112376.", + "otherId": "0", + "citationId": 275, + "otherSource": "" + } + }, + { + "aeid": 1110, + "assayComponentEndpointName": "TOX21_ARE_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ARE_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ARE_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NFE2L2. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the DNA binding intended target family, where the subfamily is basic leucine zipper.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Beta-Naphthoflavone", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 697, + "assayComponentName": "TOX21_ARE_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_ARE_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_ARE_BLA_Agonist_ratio was designed to target transcription factor activity, specifically mapping to NFE2L2 gene(s) using a positive control of Beta-Naphthoflavone", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 372, + "assayName": "TOX21_ARE_BLA_Agonist", + "assayDesc": "TOX21_ARE_BLA_Agonist is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 217, + "geneName": "nuclear factor, erythroid 2-like 2", + "description": null, + "geneSymbol": "NFE2L2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4780, + "officialSymbol": "NFE2L2", + "officialFullName": "nuclear factor, erythroid 2-like 2", + "uniprotAccessionNumber": "Q16236" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1289/EHP2589", + "url": "https://pubmed.ncbi.nlm.nih.gov/30059008/", + "pmid": 30059008, + "title": "Comprehensive Analyses and Prioritization of Tox21 10K Chemicals Affecting Mitochondrial Function by in-Depth Mechanistic Studies", + "author": "Xia M, Huang R, Shi Q, Boyd WA, Zhao J, Sun N, Rice JR, Dunlap PE, Hackstadt AJ, Bridge MF, Smith MV, Dai S, Zheng W, Chu PH, Gerhold D, Witt KL, DeVito M, Freedman JH, Austin CP, Houck KA, Thomas RS, Paules RS, Tice RR, Simeonov A", + "citation": "Xia M, Huang R, Shi Q, Boyd WA, Zhao J, Sun N, Rice JR, Dunlap PE, Hackstadt AJ, Bridge MF, Smith MV, Dai S, Zheng W, Chu PH, Gerhold D, Witt KL, DeVito M, Freedman JH, Austin CP, Houck KA, Thomas RS, Paules RS, Tice RR, Simeonov A. Comprehensive Analyses and Prioritization of Tox21 10K Chemicals Affecting Mitochondrial Function by in-Depth Mechanistic Studies. Environ Health Perspect. 2018 Jul 26;126(7):077010. doi: 10.1289/EHP2589. PMID: 30059008; PMCID: PMC6112376.", + "otherId": "0", + "citationId": 275, + "otherSource": "" + } + }, + { + "aeid": 1111, + "assayComponentEndpointName": "TOX21_HSE_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_HSE_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_HSE_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene HSF1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17-AAG", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 698, + "assayComponentName": "TOX21_HSE_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_HSE_BLA_Agonist_ch1 is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_HSE_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target transcription factor activity, specifically mapping to HSF1 gene(s) using a positive control of 17-AAG", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 373, + "assayName": "TOX21_HSE_BLA_Agonist", + "assayDesc": "TOX21_HSE_BLA_Agonist is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1112, + "assayComponentEndpointName": "TOX21_HSE_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_HSE_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_HSE_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene HSF1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17-AAG", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 699, + "assayComponentName": "TOX21_HSE_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_HSE_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_HSE_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target transcription factor activity, specifically mapping to HSF1 gene(s) using a positive control of 17-AAG", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 373, + "assayName": "TOX21_HSE_BLA_Agonist", + "assayDesc": "TOX21_HSE_BLA_Agonist is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1113, + "assayComponentEndpointName": "TOX21_HSE_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_HSE_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_HSE_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene HSF1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the DNA binding intended target family, where the subfamily is heat shock protein.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17-AAG", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "heat shock protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 700, + "assayComponentName": "TOX21_HSE_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_HSE_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity", + "assayComponentTargetDesc": "TOX21_HSE_BLA_Agonist_ratio was designed to target transcription factor activity, specifically mapping to HSF1 gene(s) using a positive control of 17-AAG", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 373, + "assayName": "TOX21_HSE_BLA_Agonist", + "assayDesc": "TOX21_HSE_BLA_Agonist is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 161, + "geneName": "heat shock transcription factor 1", + "description": null, + "geneSymbol": "HSF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3297, + "officialSymbol": "HSF1", + "officialFullName": "heat shock transcription factor 1", + "uniprotAccessionNumber": "Q00613" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1114, + "assayComponentEndpointName": "TOX21_p53_BLA_p1_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p1_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p1_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 701, + "assayComponentName": "TOX21_p53_BLA_p1_ch1", + "assayComponentDesc": "TOX21_p53_BLA_p1_ch1 is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_p53_BLA_p1_ch1 was designed to measure uncleaved reporter gene substrate to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 374, + "assayName": "TOX21_p53_BLA_p1", + "assayDesc": "TOX21_p53_BLA_p1 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1115, + "assayComponentEndpointName": "TOX21_p53_BLA_p1_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p1_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p1_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 702, + "assayComponentName": "TOX21_p53_BLA_p1_ch2", + "assayComponentDesc": "TOX21_p53_BLA_p1_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_p53_BLA_p1_ch2 was designed to measure cleaved reporter gene substrate to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 374, + "assayName": "TOX21_p53_BLA_p1", + "assayDesc": "TOX21_p53_BLA_p1 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1116, + "assayComponentEndpointName": "TOX21_p53_BLA_p1_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p1_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p1_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the DNA binding intended target family, where the subfamily is tumor suppressor.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "tumor suppressor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 703, + "assayComponentName": "TOX21_p53_BLA_p1_ratio", + "assayComponentDesc": "TOX21_p53_BLA_p1_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_p53_BLA_p1_ratio was designed to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 374, + "assayName": "TOX21_p53_BLA_p1", + "assayDesc": "TOX21_p53_BLA_p1 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 329, + "geneName": "tumor protein p53", + "description": null, + "geneSymbol": "TP53", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7157, + "officialSymbol": "TP53", + "officialFullName": "tumor protein p53", + "uniprotAccessionNumber": "P04637" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1117, + "assayComponentEndpointName": "TOX21_FXR_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_FXR_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_FXR_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR1H4. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Chenodeoxycholic acid", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 704, + "assayComponentName": "TOX21_FXR_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_FXR_BLA_Agonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_FXR_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR1H4 gene(s) using a positive control of Chenodeoxycholic acid", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 375, + "assayName": "TOX21_FXR_BLA_Agonist", + "assayDesc": "TOX21_FXR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1118, + "assayComponentEndpointName": "TOX21_FXR_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_FXR_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_FXR_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR1H4. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Chenodeoxycholic acid", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 705, + "assayComponentName": "TOX21_FXR_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_FXR_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_FXR_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR1H4 gene(s) using a positive control of Chenodeoxycholic acid", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 375, + "assayName": "TOX21_FXR_BLA_Agonist", + "assayDesc": "TOX21_FXR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1119, + "assayComponentEndpointName": "TOX21_FXR_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_FXR_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_FXR_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of receptor for gain-of-signal activity can be used to understand the reporter gene at the pathway-level as they relate to the gene NR1H4. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this ratio serves a reporter gene function to understand target activity.To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Chenodeoxycholic acid", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 706, + "assayComponentName": "TOX21_FXR_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_FXR_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_FXR_BLA_Agonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR1H4 gene(s) using a positive control of Chenodeoxycholic acid", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 375, + "assayName": "TOX21_FXR_BLA_Agonist", + "assayDesc": "TOX21_FXR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 357, + "geneName": "nuclear receptor subfamily 1, group H, member 4", + "description": null, + "geneSymbol": "NR1H4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9971, + "officialSymbol": "NR1H4", + "officialFullName": "nuclear receptor subfamily 1, group H, member 4", + "uniprotAccessionNumber": "Q96RI1" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1120, + "assayComponentEndpointName": "TOX21_FXR_BLA_Antagonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_FXR_BLA_Antagonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_FXR_BLA_Antagonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of receptor for gain-of-signal activity can be used to understand the reporter gene at the pathway-level as they relate to the gene NR1H4. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Guggulsterone", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 707, + "assayComponentName": "TOX21_FXR_BLA_Antagonist_ratio", + "assayComponentDesc": "TOX21_FXR_BLA_Antagonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_FXR_BLA_Antagonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR1H4 gene(s) using a positive control of Guggulsterone", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 376, + "assayName": "TOX21_FXR_BLA_Antagonist", + "assayDesc": "TOX21_FXR_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 357, + "geneName": "nuclear receptor subfamily 1, group H, member 4", + "description": null, + "geneSymbol": "NR1H4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9971, + "officialSymbol": "NR1H4", + "officialFullName": "nuclear receptor subfamily 1, group H, member 4", + "uniprotAccessionNumber": "Q96RI1" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1121, + "assayComponentEndpointName": "TOX21_FXR_BLA_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_FXR_BLA_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 708, + "assayComponentName": "TOX21_FXR_BLA_Antagonist_viability", + "assayComponentDesc": "TOX21_FXR_BLA_Antagonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 376, + "assayName": "TOX21_FXR_BLA_Antagonist", + "assayDesc": "TOX21_FXR_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1122, + "assayComponentEndpointName": "TOX21_PPARd_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PPARd_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PPARd_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene PPARD. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "L-165,041", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 709, + "assayComponentName": "TOX21_PPARd_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_PPARd_BLA_Agonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_PPARD_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to PPARD gene(s) using a positive control of L-165,041", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 377, + "assayName": "TOX21_PPARd_BLA_Agonist", + "assayDesc": "TOX21_PPARd_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1123, + "assayComponentEndpointName": "TOX21_PPARd_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PPARd_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PPARd_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene PPARD. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "L-165,041", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 710, + "assayComponentName": "TOX21_PPARd_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_PPARd_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_PPARD_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to PPARD gene(s) using a positive control of L-165,041", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 377, + "assayName": "TOX21_PPARd_BLA_Agonist", + "assayDesc": "TOX21_PPARd_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1124, + "assayComponentEndpointName": "TOX21_PPARd_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PPARd_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PPARd_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene PPARD. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "L-165,041", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 711, + "assayComponentName": "TOX21_PPARd_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_PPARd_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_PPARD_BLA_Agonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to PPARD gene(s) using a positive control of L-165,041", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 377, + "assayName": "TOX21_PPARd_BLA_Agonist", + "assayDesc": "TOX21_PPARd_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 249, + "geneName": "peroxisome proliferator-activated receptor delta", + "description": null, + "geneSymbol": "PPARD", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5467, + "officialSymbol": "PPARD", + "officialFullName": "peroxisome proliferator-activated receptor delta", + "uniprotAccessionNumber": "Q03181" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1125, + "assayComponentEndpointName": "TOX21_PPARd_BLA_Antagonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PPARd_BLA_Antagonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PPARd_BLA_Antagonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene PPARD. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "MK886", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 712, + "assayComponentName": "TOX21_PPARd_BLA_Antagonist_ratio", + "assayComponentDesc": "TOX21_PPARd_BLA_Antagonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_PPARD_BLA_Antagonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to PPARD gene(s) using a positive control of MK886", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 378, + "assayName": "TOX21_PPARd_BLA_Antagonist", + "assayDesc": "TOX21_PPARd_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 249, + "geneName": "peroxisome proliferator-activated receptor delta", + "description": null, + "geneSymbol": "PPARD", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5467, + "officialSymbol": "PPARD", + "officialFullName": "peroxisome proliferator-activated receptor delta", + "uniprotAccessionNumber": "Q03181" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1126, + "assayComponentEndpointName": "TOX21_PPARd_BLA_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_PPARd_BLA_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 713, + "assayComponentName": "TOX21_PPARd_BLA_Antagonist_viability", + "assayComponentDesc": "TOX21_PPARd_BLA_Antagonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 378, + "assayName": "TOX21_PPARd_BLA_Antagonist", + "assayDesc": "TOX21_PPARd_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1127, + "assayComponentEndpointName": "TOX21_PPARg_BLA_Antagonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PPARg_BLA_Antagonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PPARg_BLA_Antagonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene PPARG. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GW9662", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 714, + "assayComponentName": "TOX21_PPARg_BLA_Antagonist_ratio", + "assayComponentDesc": "TOX21_PPARg_BLA_Antagonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_PPARg_BLA_Antagonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to PPARG gene(s) using a positive control of GW9662", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 379, + "assayName": "TOX21_PPARg_BLA_Antagonist", + "assayDesc": "TOX21_PPARg_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 250, + "geneName": "peroxisome proliferator-activated receptor gamma", + "description": null, + "geneSymbol": "PPARG", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5468, + "officialSymbol": "PPARG", + "officialFullName": "peroxisome proliferator-activated receptor gamma", + "uniprotAccessionNumber": "P37231" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1128, + "assayComponentEndpointName": "TOX21_PPARg_BLA_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_PPARg_BLA_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 715, + "assayComponentName": "TOX21_PPARg_BLA_Antagonist_viability", + "assayComponentDesc": "TOX21_PPARg_BLA_Antagonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 379, + "assayName": "TOX21_PPARg_BLA_Antagonist", + "assayDesc": "TOX21_PPARg_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1129, + "assayComponentEndpointName": "TOX21_VDR_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_VDR_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_VDR_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP24A1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Calcitriol", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 716, + "assayComponentName": "TOX21_VDR_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_VDR_BLA_Agonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_VDR_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR1I1 gene(s) using a positive control of Calcitriol", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 380, + "assayName": "TOX21_VDR_BLA_Agonist", + "assayDesc": "TOX21_VDR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-018-27055-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/29891985/", + "pmid": 29891985, + "title": "Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays", + "author": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW", + "citation": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW. Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays. Sci Rep. 2018 Jun 11;8(1):8883. doi: 10.1038/s41598-018-27055-3. PMID: 29891985; PMCID: PMC5995905.", + "otherId": "0", + "citationId": 270, + "otherSource": "" + } + }, + { + "aeid": 1130, + "assayComponentEndpointName": "TOX21_VDR_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_VDR_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_VDR_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene CYP24A1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Calcitriol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 717, + "assayComponentName": "TOX21_VDR_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_VDR_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_VDR_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR1I1 gene(s) using a positive control of Calcitriol", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 380, + "assayName": "TOX21_VDR_BLA_Agonist", + "assayDesc": "TOX21_VDR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-018-27055-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/29891985/", + "pmid": 29891985, + "title": "Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays", + "author": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW", + "citation": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW. Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays. Sci Rep. 2018 Jun 11;8(1):8883. doi: 10.1038/s41598-018-27055-3. PMID: 29891985; PMCID: PMC5995905.", + "otherId": "0", + "citationId": 270, + "otherSource": "" + } + }, + { + "aeid": 1131, + "assayComponentEndpointName": "TOX21_VDR_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_VDR_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_VDR_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of receptor for gain-of-signal activity can be used to understand the reporter gene at the pathway-level as they relate to the gene CYP24A1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Calcitriol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 718, + "assayComponentName": "TOX21_VDR_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_VDR_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_VDR_BLA_Agonist_ratio was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR1I1 gene(s) using a positive control of Calcitriol", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 380, + "assayName": "TOX21_VDR_BLA_Agonist", + "assayDesc": "TOX21_VDR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 95, + "geneName": "cytochrome P450, family 24, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP24A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1591, + "officialSymbol": "CYP24A1", + "officialFullName": "cytochrome P450, family 24, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "Q07973" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-018-27055-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/29891985/", + "pmid": 29891985, + "title": "Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays", + "author": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW", + "citation": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW. Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays. Sci Rep. 2018 Jun 11;8(1):8883. doi: 10.1038/s41598-018-27055-3. PMID: 29891985; PMCID: PMC5995905.", + "otherId": "0", + "citationId": 270, + "otherSource": "" + } + }, + { + "aeid": 1132, + "assayComponentEndpointName": "TOX21_VDR_BLA_Antagonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_VDR_BLA_Antagonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_VDR_BLA_Antagonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP24A1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1alpha,25-Dihydroxy vitamin D3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 719, + "assayComponentName": "TOX21_VDR_BLA_Antagonist_ratio", + "assayComponentDesc": "TOX21_VDR_BLA_Antagonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_VDR_BLA_Antagonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR1I1 gene(s) using a positive control of Tetraoctyl ammonium bromide", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 381, + "assayName": "TOX21_VDR_BLA_Antagonist", + "assayDesc": "TOX21_VDR_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 95, + "geneName": "cytochrome P450, family 24, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP24A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1591, + "officialSymbol": "CYP24A1", + "officialFullName": "cytochrome P450, family 24, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "Q07973" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-018-27055-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/29891985/", + "pmid": 29891985, + "title": "Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays", + "author": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW", + "citation": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW. Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays. Sci Rep. 2018 Jun 11;8(1):8883. doi: 10.1038/s41598-018-27055-3. PMID: 29891985; PMCID: PMC5995905.", + "otherId": "0", + "citationId": 270, + "otherSource": "" + } + }, + { + "aeid": 1133, + "assayComponentEndpointName": "TOX21_VDR_BLA_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_VDR_BLA_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 720, + "assayComponentName": "TOX21_VDR_BLA_Antagonist_viability", + "assayComponentDesc": "TOX21_VDR_BLA_Antagonist_viability is one of 2 assay component(s) measured or calculated from the TOX21_VDR_BLA_Antagonist assay. It is designed to make measurements of ATP content, a form of viability reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 381, + "assayName": "TOX21_VDR_BLA_Antagonist", + "assayDesc": "TOX21_VDR_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1038/s41598-018-27055-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/29891985/", + "pmid": 29891985, + "title": "Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays", + "author": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW", + "citation": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW. Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays. Sci Rep. 2018 Jun 11;8(1):8883. doi: 10.1038/s41598-018-27055-3. PMID: 29891985; PMCID: PMC5995905.", + "otherId": "0", + "citationId": 270, + "otherSource": "" + } + }, + { + "aeid": 2007, + "assayComponentEndpointName": "ATG_frER2_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frER2_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1903, + "assayComponentName": "ATG_frER2_XSP2", + "assayComponentDesc": "ATG_frER2_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the frog estrogen receptor. [GeneSymbol:esr2.L | GeneID: 100174814| Uniprot_SwissProt_Accession:A0A1L8FA50].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frER2 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1481, + "geneName": "estrogen receptor 2 L homeolog", + "description": "estrogen receptor 2 L homeolog [ Xenopus laevis (African clawed frog) ]", + "geneSymbol": "esr2.L", + "organismId": 46, + "trackStatus": null, + "entrezGeneId": 100174814, + "officialSymbol": "esr2.L", + "officialFullName": "estrogen receptor 2 L homeolog", + "uniprotAccessionNumber": "A0A1L8FA50" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2009, + "assayComponentEndpointName": "ATG_mPPARg_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_mPPARg_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARg. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1904, + "assayComponentName": "ATG_mPPARg_XSP2", + "assayComponentDesc": "ATG_mPPARg_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element PPARg, which is responsive to the mouse peroxisome proliferator activated receptor gamma. [GeneSymbol:Pparg | GeneID: 19016| Uniprot_SwissProt_Accession:P37238].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-mPPARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1478, + "geneName": "peroxisome proliferator activated receptor gamma", + "description": "peroxisome proliferator activated receptor gamma [ Mus musculus(house mouse) ]", + "geneSymbol": "Pparg", + "organismId": 2, + "trackStatus": null, + "entrezGeneId": 19016, + "officialSymbol": "Pparg", + "officialFullName": "peroxisome proliferator activated receptor gamma", + "uniprotAccessionNumber": "P37238" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2011, + "assayComponentEndpointName": "ATG_zfPPARg_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfPPARg_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARg. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1905, + "assayComponentName": "ATG_zfPPARg_XSP2", + "assayComponentDesc": "ATG_zfPPARg_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element PPARg, which is responsive to the zebrafish peroxisome proliferator activated receptor gamma. [GeneSymbol: pparg | GeneID: 557037| Uniprot_SwissProt_Accession:A6XMH6].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfPPARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1471, + "geneName": "peroxisome proliferator-activated receptor gamma", + "description": "peroxisome proliferator-activated receptor gamma [ Danio rerio(zebrafish) ]", + "geneSymbol": "pparg", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 557037, + "officialSymbol": "pparg", + "officialFullName": "peroxisome proliferator-activated receptor gamma", + "uniprotAccessionNumber": "A6XMH6" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2013, + "assayComponentEndpointName": "ATG_hPPARg_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hPPARg_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARg. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1906, + "assayComponentName": "ATG_hPPARg_XSP2", + "assayComponentDesc": "ATG_hPPARg_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element PPARg, which is responsive to the human peroxisome proliferator activated receptor gamma. [GeneSymbol:PPARG | GeneID: 5468| Uniprot_SwissProt_Accession:P37231].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-PPARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 250, + "geneName": "peroxisome proliferator-activated receptor gamma", + "description": null, + "geneSymbol": "PPARG", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5468, + "officialSymbol": "PPARG", + "officialFullName": "peroxisome proliferator-activated receptor gamma", + "uniprotAccessionNumber": "P37231" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2015, + "assayComponentEndpointName": "ATG_mPXR_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_mPXR_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PXR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1907, + "assayComponentName": "ATG_mPXR_XSP2", + "assayComponentDesc": "ATG_mPXR_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element PXR, which is responsive to the mouse pregnane X receptor. [GeneSymbol: NR1IA | GeneID: 8856| Uniprot_SwissProt_Accession:O75469].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "NA", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 350, + "geneName": "nuclear receptor subfamily 1, group I, member 2", + "description": null, + "geneSymbol": "NR1I2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8856, + "officialSymbol": "NR1I2", + "officialFullName": "nuclear receptor subfamily 1, group I, member 2", + "uniprotAccessionNumber": "O75469" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2017, + "assayComponentEndpointName": "ATG_trTRa_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_trTRa_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1908, + "assayComponentName": "ATG_trTRa_XSP2", + "assayComponentDesc": "ATG_trTRa_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element TRa, which is responsive to the turtle thyroid hormone receptor, alpha. [GeneSymbol: THRA | GeneID: 101949057| Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-trTRa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1466, + "geneName": "thyroid hormone receptor, alpha", + "description": "thyroid hormone receptor, alpha [ Chrysemys picta (painted turtle) ]", + "geneSymbol": "THRA", + "organismId": 42, + "trackStatus": null, + "entrezGeneId": 101949057, + "officialSymbol": "NA", + "officialFullName": "NA", + "uniprotAccessionNumber": "NA" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2019, + "assayComponentEndpointName": "ATG_zfTRa_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfTRa_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1909, + "assayComponentName": "ATG_zfTRa_XSP2", + "assayComponentDesc": "ATG_zfTRa_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element TRa, which is responsive to the zebrafish thyroid hormone receptor, alpha a. [GeneSymbol: thraa | GeneID: 30670| Uniprot_SwissProt_Accession: Q98867].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfTRa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1472, + "geneName": "thyroid hormone receptor alpha a", + "description": "thyroid hormone receptor alpha a [ Danio rerio (zebrafish) ]", + "geneSymbol": "thraa", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 30670, + "officialSymbol": "thraa", + "officialFullName": "thyroid hormone receptor alpha a", + "uniprotAccessionNumber": "Q98867" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2021, + "assayComponentEndpointName": "ATG_zfTRb_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfTRb_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1910, + "assayComponentName": "ATG_zfTRb_XSP2", + "assayComponentDesc": "ATG_zfTRb_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element TRa, which is responsive to the zebrafish thyroid hormone receptor, beta. [GeneSymbol: thrb | GeneID: 30607| Uniprot_SwissProt_Accession: Q9PVE4].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfTRb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1473, + "geneName": "thyroid hormone receptor beta", + "description": "thyroid hormone receptor beta [ Danio rerio (zebrafish) ]", + "geneSymbol": "thrb", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 30607, + "officialSymbol": "thrb", + "officialFullName": "thyroid hormone receptor beta", + "uniprotAccessionNumber": "Q9PVE4" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2025, + "assayComponentEndpointName": "ATG_frTRa_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frTRa_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1912, + "assayComponentName": "ATG_frTRa_XSP2", + "assayComponentDesc": "ATG_frTRa_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element TRa, which is responsive to the frog thyroid hormone receptor, alpha L homeolog. [GeneSymbol: thra.L | GeneID: 397942| Uniprot_SwissProt_Accession: P15204].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frTRa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1482, + "geneName": "thyroid hormone receptor, alpha L homeolog", + "description": "thyroid hormone receptor, alpha L homeolog [ Xenopus laevis(African clawed frog) ]", + "geneSymbol": "thra.L", + "organismId": 46, + "trackStatus": null, + "entrezGeneId": 397942, + "officialSymbol": "thra.L", + "officialFullName": "thyroid hormone receptor, alpha L homeolog", + "uniprotAccessionNumber": "P15204" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2027, + "assayComponentEndpointName": "ATG_hTRa_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hTRa_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1913, + "assayComponentName": "ATG_hTRa_XSP2", + "assayComponentDesc": "ATG_hTRa_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element TRa, which is responsive to the human thyroid hormone receptor, alpha. [GeneSymbol: THRA | GeneID: 7067| Uniprot_SwissProt_Accession: P10827].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-THRa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 321, + "geneName": "thyroid hormone receptor, alpha", + "description": null, + "geneSymbol": "THRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7067, + "officialSymbol": "THRA", + "officialFullName": "thyroid hormone receptor, alpha", + "uniprotAccessionNumber": "P10827" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2029, + "assayComponentEndpointName": "ATG_hTRb_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hTRb_XSP2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1914, + "assayComponentName": "ATG_hTRb_XSP2", + "assayComponentDesc": "ATG_hTRb_XSP2 is one of 29 assay components measured or calculated from the ATG_XSP2_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element TRa, which is responsive to the human thyroid hormone receptor, beta. [GeneSymbol: THRB | GeneID: 7068| Uniprot_SwissProt_Accession: P10828].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-THR-b RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 571, + "assayName": "ATG_XSP2_multi-species_TRANS", + "assayDesc": "ATG_XSP2_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp2 included 3 nM 6-alpha-fluorotestosterone and 1.5 nM norgestrel to stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 322, + "geneName": "thyroid hormone receptor, beta", + "description": null, + "geneSymbol": "THRB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7068, + "officialSymbol": "THRB", + "officialFullName": "thyroid hormone receptor, beta", + "uniprotAccessionNumber": "P10828" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2031, + "assayComponentEndpointName": "ATG_XTT_Cytotoxicity_XSP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_XTT_Cytotoxicity_XSP2 was analyzed into 1 assay endpoint. This assay endpoint, ATG_XTT_Cytotoxicity_XSP2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in the viability. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1915, + "assayComponentName": "ATG_XTT_Cytotoxicity_XSP2", + "assayComponentDesc": "ATG_XTT_Cytotoxicity_XSP2 is an assay component measured from the ATG_XSP2_XTT_Cytotoxicity_multi-species assay. It is designed to make measurements of cell number, a form of viability reporter, as detected with fluorescence intensity signals by XTT cytotoxicity assay technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction involving the key substrate [XTT reagent] are correlated to the viability of the mitochondria in the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell number", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence Intensity", + "detectionTechnology": "XTT cytotoxicity assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "XTT reagent", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 572, + "assayName": "ATG_XSP2_XTT_Cytotoxicity_multi-species", + "assayDesc": "ATG_XSP2_XTT_Cytotoxicity_multi-species is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2037, + "assayComponentEndpointName": "CPHEA_Stoker_NIS_Inhibition_RAIU", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CPHEA_Stoker_NIS_Inhibition_RAIU was analyzed at the endpoint, CPHEA_Stoker_NIS_Inhibition_RAIU, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Measures of radioactive substrate uptake for loss-of-signal activity can be used to understand the effects on transporter function at the pathway level as they relate to the sodium-iodide symporter, gene SLC5A5. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is sodium-iodide symporter (NIS).", + "assayFunctionType": "transporter", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NaClO4", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "sodium-iodide symporter (NIS)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1919, + "assayComponentName": "CPHEA_Stoker_NIS_Inhibition_RAIU", + "assayComponentDesc": "CPHEA_Stoker_NIS_Inhibition_RAIU is one of 2 assay components measured from the CPHEA_Stoker_NIS assay. It is designed to make measurements of radioactive substrate uptake to understand transporter function, as detected with 125-i signals by MicroBeta radioactivity plate reader technology.", + "assayComponentTargetDesc": "The sodium iodide symporter (NIS) is a transmembrane glycoprotein that mediates iodide uptake into the thyroid gland as the initial step of thyroid hormone biosynthesis. Inhibition of iodide uptake through the thyroid NIS can result in decreased thyroid hormone biosynthesis. The radioactive iodide uptake (RAIU) assay can be used to detect thyroid disrupting chemicals that inhibit the human sodium iodide symporter (NIS).", + "parameterReadoutType": "single", + "assayDesignType": "transporter function", + "assayDesignTypeSub": "radioactive substrate uptake", + "biologicalProcessTarget": "regulation of transporter activity", + "detectionTechnologyType": "radiometry", + "detectionTechnologyTypeSub": "radiodetection", + "detectionTechnology": "MicroBeta radioactivity plate reader", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "125-I", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "substrate uptake", + "aid": 574, + "assayName": "CPHEA_Stoker_NIS", + "assayDesc": "CPHEA_Stoker_NIS is a cell-based, single-readout assay that uses hNIS-HEK293T-EPA, a novel human kidney cell line expressing human NIS, with measurements taken at 2 hours after chemical dosing in a 96-well plate. This radioactive iodide uptake (RAIU) assay is used to identify inhibitors of NIS-mediated iodide uptake. A parallel cytoxicity assay (Cell Titer Glo, Promega) was also run in the same cell line.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": null, + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 21, + "assaySourceName": "CPHEA_STOKER", + "assaySourceLongName": "CPHEA Stoker and Laws Labs", + "assaySourceDesc": "The Stoker and Laws laboratories at the EPA Center for Public Health and Environmental Assessment work on the development and implementation of high-throughput assays, particularly related to the sodium-iodide cotransporter (NIS).", + "gene": { + "geneId": 1462, + "geneName": "solute carrier family 5 member 5", + "description": null, + "geneSymbol": "SLC5A5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6528, + "officialSymbol": "SLC5A5", + "officialFullName": "solute carrier family 5 member 5", + "uniprotAccessionNumber": "Q92911" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1007/s00204-021-03006-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33656581/", + "pmid": 33656581, + "title": "Expanded high-throughput screening and chemotype-enrichment analysis of the phase II: e1k ToxCast library for human sodium-iodide symporter (NIS) inhibition", + "author": "Wang J, Richard AM, Murr AS, Buckalew AR, Lougee RR, Shobair M, Hallinger DR, Laws SC, Stoker TE", + "citation": "Wang J, Richard AM, Murr AS, Buckalew AR, Lougee RR, Shobair M, Hallinger DR, Laws SC, Stoker TE. Expanded high-throughput screening and chemotype-enrichment analysis of the phase II: e1k ToxCast library for human sodium-iodide symporter (NIS) inhibition. Arch Toxicol. 2021 May;95(5):1723-1737. doi: 10.1007/s00204-021-03006-2. Epub 2021 Mar 3. PMID: 33656581.", + "otherId": "0", + "citationId": 241, + "otherSource": "" + } + }, + { + "aeid": 2038, + "assayComponentEndpointName": "TOX21_TSHR_HTRF_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TSHR_HTRF_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TSHR_HTRF_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TSHR. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TSH", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1920, + "assayComponentName": "TOX21_TSHR_HTRF_Agonist_ch1", + "assayComponentDesc": "TOX21_TSHR_HTRF_Agonist_ch1 is an assay readout measuring endogenous cAMP generated by receptor activity and detected with specific antibody. The signal is derived from the donor (Europium-cryptate) antibody emission and is used to calculate the ratio of acceptor (d2) emission (ch2) to donor emission (ch1) used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_TSHR_HTRF_Agonist_ch1 was designed to measure labeled anti-cAMP antibody donor emission to target receptor activation, specifically mapping to TSHR gene(s) using a positive control of TSH", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Homogeneous Time Resolved Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "d2-labeled cAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 575, + "assayName": "TOX21_TSHR_Agonist", + "assayDesc": "Tox21_TSHR_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 0.5 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2039, + "assayComponentEndpointName": "TOX21_TSHR_HTRF_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TSHR_HTRF_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TSHR_HTRF_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene TSHR. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TSH", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1921, + "assayComponentName": "TOX21_TSHR_HTRF_Agonist_ch2", + "assayComponentDesc": "TOX21_TSHR_HTRF_Agonist_ch2 is an assay readout measuring endogenous cAMP generated by receptor activity and detected with specific antibody. The signal is derived from the acceptor (Europium-cryptate) antibody emission and is used to calculate the ratio of acceptor emission (ch2) to donor emission (ch1) used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_TSHR_HTRF_Agonist_ch2 was designed to measure labeled cAMP acceptor emission to target receptor activation, specifically mapping to TSHR gene(s) using a positive control of TSH", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Homogeneous Time Resolved Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 575, + "assayName": "TOX21_TSHR_Agonist", + "assayDesc": "Tox21_TSHR_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 0.5 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2040, + "assayComponentEndpointName": "TOX21_TSHR_HTRF_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TSHR_HTRF_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TSHR_HTRF_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TSHR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is thyrotropin-releasing hormone receptor.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TSH", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "thyrotropin-releasing hormone receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1922, + "assayComponentName": "TOX21_TSHR_HTRF_Agonist_ratio", + "assayComponentDesc": "TOX21_TSHR_HTRF_Agonist_ratio is one of one assay component(s) measured or calculated from the TOX21_TSHR_HTRF_Agonist assay. It is designed to make measurements of TSHR agonism, with cAMP as an indicator of TSHR activation.", + "assayComponentTargetDesc": "TOX21_TSHR_HTRF_Agonist_ratio was designed to target receptor activation through increased cAMP generation, specifically mapping to TSHR gene(s) using a positive control of TSH.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "cAMP measurement", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Homogeneous Time Resolved Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "d2-labeled cAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 575, + "assayName": "TOX21_TSHR_Agonist", + "assayDesc": "Tox21_TSHR_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 0.5 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 1460, + "geneName": "thyroid stimulating hormone receptor", + "description": "thyroid stimulating hormone receptor", + "geneSymbol": "TSHR", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 7253, + "officialSymbol": "TSHR", + "officialFullName": "thyroid stimulating hormone receptor", + "uniprotAccessionNumber": null + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": null + }, + { + "aeid": 2041, + "assayComponentEndpointName": "TOX21_TSHR_HTRF_Antagonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TSHR_HTRF_Antagonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TSHR_HTRF_Antagonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene TSHR. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "no TSH stimulation", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1923, + "assayComponentName": "TOX21_TSHR_HTRF_Antagonist_ch1", + "assayComponentDesc": "TOX21_TSHR_HTRF_Antagonist_ch1 is an assay readout measuring endogenous cAMP generated by receptor activity and detected with specific antibody. The signal is derived from the donor (Europium-cryptate) antibody emission and is used to calculate the ratio of acceptor (d2) emission (ch2) to donor emission (ch1) used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_TSHR_HTRF_Antagonist_ch1 was designed to measure labeled anti-cAMP antibody donor emission to target receptor activation, specifically mapping to TSHR gene(s) using a positive control of no TSH stimulation", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Homogeneous Time Resolved Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "d2-labeled cAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 576, + "assayName": "TOX21_TSHR_Antagonist", + "assayDesc": "Tox21_TSHR_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 0.5 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1854, + "assayComponentEndpointName": "TOX21_MMP_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_MMP_ratio was analyzed into 1 assay endpoint. The assay endpoin, TOX21_MMP_ratio, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of membrane potential reporter, gain-of-signal activity can be used to understand changes in the signaling. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is organelle conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "FCCP", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "organelle conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 534, + "assayComponentName": "TOX21_MMP_ratio", + "assayComponentDesc": "TOX21_MMP_ratio is one of 2 assay component(s) measured or calculated from the TOX21_MMP assay. It is designed to make measurements of dye binding, a form of membrane potential reporter, as detected with fluorescence intensity signals by homogenous mitochondrial membrane potential assay technology.", + "assayComponentTargetDesc": "Mito-MPS is used as a stain for the membrane potential of the mitochondria.", + "parameterReadoutType": "multiple", + "assayDesignType": "membrane potential reporter", + "assayDesignTypeSub": "dye binding", + "biologicalProcessTarget": "mitochondrial depolarization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "homogenous mitochondrial membrane potential assay", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Mito-MPS", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 324, + "assayName": "TOX21_MMP", + "assayDesc": "TOX21_MMP (Mitochondrial Membrane Potential) is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1152/physiolgenomics.00161.2011", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/22433785", + "pmid": 22433785, + "title": "Application of a homogenous membrane potential assay to assess mitochondrial function", + "author": "Sakamuru S, Li X, Attene-Ramos MS, Huang R, Lu J, Shou L, Shen M, Tice RR, Austin CP, Xia M", + "citation": "Sakamuru S, Li X, Attene-Ramos MS, Huang R, Lu J, Shou L, Shen M, Tice RR, Austin CP, Xia M. Application of a homogenous membrane potential assay to assess mitochondrial function. Physiol Genomics. 2012 May 1;44(9):495-503. doi: 10.1152/physiolgenomics.00161.2011. Epub 2012 Mar 20. PubMed PMID: 22433785; PubMed Central PMCID: PMC3426425.", + "otherId": "0", + "citationId": 219, + "otherSource": "" + } + }, + { + "aeid": 2042, + "assayComponentEndpointName": "TOX21_TSHR_HTRF_Antagonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TSHR_HTFR_Antagonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TSHR_HTFR_Antagonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TSHR. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "no TSH stimulation", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1924, + "assayComponentName": "TOX21_TSHR_HTRF_Antagonist_ch2", + "assayComponentDesc": "TOX21_TSHR_HTRF_Antagonist_ch2 is an assay readout measuring endogenous cAMP generated by receptor activity and detected with specific antibody. The signal is derived from the acceptor (d2) antibody emission and is used to calculate the ratio of acceptor emission (ch2) to donor emission (ch1) used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_TSHR_HTRF_Antagonist_ch2 was designed to measure labeled cAMP acceptor emission to target receptor activation, specifically mapping to TSHR gene(s) using a positive control of no TSH stimulation", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Homogeneous Time Resolved Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "d2-labeled cAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 576, + "assayName": "TOX21_TSHR_Antagonist", + "assayDesc": "Tox21_TSHR_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 0.5 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2043, + "assayComponentEndpointName": "TOX21_TSHR_HTRF_Antagonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TSHR_HTRF_Antagonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TSHR_HTRF_Antagonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TSHR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this one serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is thyrotropin-releasing hormone receptor.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "no TSH stimulation", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "thyrotropin-releasing hormone receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1925, + "assayComponentName": "TOX21_TSHR_HTRF_Antagonist_ratio", + "assayComponentDesc": "TOX21_TSHR_HTRF_Antagonist_ratio is one of one assay component(s) measured or calculated from the TOX21_TSHR_Antagonist assay. It is designed to make measurements of TSHR antagonism, with cAMP as an indicator of TSHR activation.", + "assayComponentTargetDesc": "TOX21_TSHR_HTRF_Antagonist_ratio was designed to target receptor inhibition through decreased cAMP generation, specifically mapping to TSHR gene(s) using a positive control of no TSH stimulation", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "cAMP measurement", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Homogeneous Time Resolved Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "d2-labeled cAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 576, + "assayName": "TOX21_TSHR_Antagonist", + "assayDesc": "Tox21_TSHR_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 0.5 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 1460, + "geneName": "thyroid stimulating hormone receptor", + "description": "thyroid stimulating hormone receptor", + "geneSymbol": "TSHR", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 7253, + "officialSymbol": "TSHR", + "officialFullName": "thyroid stimulating hormone receptor", + "uniprotAccessionNumber": null + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": null + }, + { + "aeid": 2044, + "assayComponentEndpointName": "TOX21_TSHR_wt_Agonist_HTRF_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TSHR_HTRF_wt_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TSHR_HTRF_wt_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss of signal activity can be used to understand changes in the reporter gene as they relate to the gene TSHR. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Forskolin", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1926, + "assayComponentName": "TOX21_TSHR_wt_Agonist_HTRF_ch1", + "assayComponentDesc": "TOX21_TSHR_wt_Agonist_HTRF_ch1 is an assay readout measuring endogenous cAMP and detected with specific antibody. The signal is derived from the donor (Europium-cryptate) antibody emission and is used to calculate the ratio of acceptor emission (ch2) to donor emission (ch1) used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_TSHR_wt_HTRF_ch1 was designed to measure labeled anti-cAMP antibody donor emission to target receptor activity at the protein (receptor) level, specifically mapping to TSRH gene(s) using a positive control of forskolin", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Homogeneous Time Resolved Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "d2-labeled cAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 577, + "assayName": "TOX21_TSHR_wt", + "assayDesc": "Tox21_TSHR_wt is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 0.5 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2045, + "assayComponentEndpointName": "TOX21_TSHR_wt_Agonist_HTRF_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TSHR_HTRF_wt_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TSHR_HTRF_wt_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TSHR. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Forskolin", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1927, + "assayComponentName": "TOX21_TSHR_wt_Agonist_HTRF_ch2", + "assayComponentDesc": "TOX21_TSHR_wt_Agonist_HTRF_ch2 is an assay readout measuring endogenous cAMP and detected with specific antibody. The signal is derived from the acceptor (d2) antibody emission and is used to calculate the ratio of acceptor emission (ch2) to donor emission (ch1) used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_TSHR_wt_HTRF_Agonist_ch2 was designed to measure labeled cAMP acceptor emission to target receptor activation, specifically mapping to TSHR gene(s) using a positive control of forskolin", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Homogeneous Time Resolved Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "d2-labeled cAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 577, + "assayName": "TOX21_TSHR_wt", + "assayDesc": "Tox21_TSHR_wt is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 0.5 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2046, + "assayComponentEndpointName": "TOX21_TSHR_wt_Agonist_HTRF_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TSHR_HTRF_wt_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TSHR_HTRF_wt_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TSHR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is thyrotropin-releasing hormone receptor.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Forskolin", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "thyrotropin-releasing hormone receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1928, + "assayComponentName": "TOX21_TSHR_wt_Agonist_HTRF_ratio", + "assayComponentDesc": "TOX21_TSHR_wt_Agonist_HTRF_ratio is one of one assay component(s) measured or calculated from the TOX21_TSHR_wt assay. It is designed to indicate background cAMP activity.", + "assayComponentTargetDesc": "TOX21_TSHR_wt_HTRF_ratio was designed to target background cAMP generation in cells lacking TSHR", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "cAMP measurement", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Homogeneous Time Resolved Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "d2-labeled cAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 577, + "assayName": "TOX21_TSHR_wt", + "assayDesc": "Tox21_TSHR_wt is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 0.5 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 1460, + "geneName": "thyroid stimulating hormone receptor", + "description": "thyroid stimulating hormone receptor", + "geneSymbol": "TSHR", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 7253, + "officialSymbol": "TSHR", + "officialFullName": "thyroid stimulating hormone receptor", + "uniprotAccessionNumber": null + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": null + }, + { + "aeid": 2047, + "assayComponentEndpointName": "TOX21_CAR_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_CAR_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_CAR_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR1I3. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "CITCO", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "xenobiotic", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1929, + "assayComponentName": "TOX21_CAR_Agonist", + "assayComponentDesc": "TOX21_CAR_Agonist is one of one assay component(s) measured or calculated from the TOX21_CAR_Agonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "TOX21_CAR_Agonist assay was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human constitutive androstane receptor (CAR) [GeneSymbol:NR1I3]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 578, + "assayName": "TOX21_CAR_Agonist", + "assayDesc": "TOX21_CAR_Agonist is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 356, + "geneName": "nuclear receptor subfamily 1, group I, member 3", + "description": null, + "geneSymbol": "NR1I3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9970, + "officialSymbol": "NR1I3", + "officialFullName": "nuclear receptor subfamily 1, group I, member 3", + "uniprotAccessionNumber": "Q14994" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfy242", + "url": "https://pubmed.ncbi.nlm.nih.gov/30247703/", + "pmid": 30247703, + "title": "Identification of Modulators That Activate the Constitutive Androstane Receptor From the Tox21 10K Compound Library", + "author": "Lynch C, Mackowiak B, Huang R, Li L, Heyward S, Sakamuru S, Wang H, Xia M", + "citation": "Lynch C, Mackowiak B, Huang R, Li L, Heyward S, Sakamuru S, Wang H, Xia M. Identification of Modulators That Activate the Constitutive Androstane Receptor From the Tox21 10K Compound Library. Toxicol Sci. 2019 Jan 1;167(1):282-292. doi: 10.1093/toxsci/kfy242. PMID: 30247703; PMCID: PMC6657574.", + "otherId": "0", + "citationId": 272, + "otherSource": "" + } + }, + { + "aeid": 2048, + "assayComponentEndpointName": "TOX21_CAR_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_CAR_Agonist_viabillity used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1930, + "assayComponentName": "TOX21_CAR_Agonist_viability", + "assayComponentDesc": "TOX21_CAR_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 578, + "assayName": "TOX21_CAR_Agonist", + "assayDesc": "TOX21_CAR_Agonist is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfy242", + "url": "https://pubmed.ncbi.nlm.nih.gov/30247703/", + "pmid": 30247703, + "title": "Identification of Modulators That Activate the Constitutive Androstane Receptor From the Tox21 10K Compound Library", + "author": "Lynch C, Mackowiak B, Huang R, Li L, Heyward S, Sakamuru S, Wang H, Xia M", + "citation": "Lynch C, Mackowiak B, Huang R, Li L, Heyward S, Sakamuru S, Wang H, Xia M. Identification of Modulators That Activate the Constitutive Androstane Receptor From the Tox21 10K Compound Library. Toxicol Sci. 2019 Jan 1;167(1):282-292. doi: 10.1093/toxsci/kfy242. PMID: 30247703; PMCID: PMC6657574.", + "otherId": "0", + "citationId": 272, + "otherSource": "" + } + }, + { + "aeid": 2049, + "assayComponentEndpointName": "TOX21_CAR_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_CAR_Antagonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_CAR_Antagonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR1I3. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "PK11195", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "xenobiotic", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1931, + "assayComponentName": "TOX21_CAR_Antagonist", + "assayComponentDesc": "TOX21_CAR_Antagonist is one of one assay component(s) measured or calculated from the TOX21_CAR_Antagonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "TOX21_CAR_Antagonist assay was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to antagonist activity regulated by the human constitutive androstane receptor (CAR) [GeneSymbol:NR1I3] stimulated with CITCO", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 579, + "assayName": "TOX21_CAR_Antagonist", + "assayDesc": "TOX21_CAR_Antagonist is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 356, + "geneName": "nuclear receptor subfamily 1, group I, member 3", + "description": null, + "geneSymbol": "NR1I3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9970, + "officialSymbol": "NR1I3", + "officialFullName": "nuclear receptor subfamily 1, group I, member 3", + "uniprotAccessionNumber": "Q14994" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfy242", + "url": "https://pubmed.ncbi.nlm.nih.gov/30247703/", + "pmid": 30247703, + "title": "Identification of Modulators That Activate the Constitutive Androstane Receptor From the Tox21 10K Compound Library", + "author": "Lynch C, Mackowiak B, Huang R, Li L, Heyward S, Sakamuru S, Wang H, Xia M", + "citation": "Lynch C, Mackowiak B, Huang R, Li L, Heyward S, Sakamuru S, Wang H, Xia M. Identification of Modulators That Activate the Constitutive Androstane Receptor From the Tox21 10K Compound Library. Toxicol Sci. 2019 Jan 1;167(1):282-292. doi: 10.1093/toxsci/kfy242. PMID: 30247703; PMCID: PMC6657574.", + "otherId": "0", + "citationId": 272, + "otherSource": "" + } + }, + { + "aeid": 2050, + "assayComponentEndpointName": "TOX21_CAR_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_CAR_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1932, + "assayComponentName": "TOX21_CAR_Antagonist_viability", + "assayComponentDesc": "TOX21_CAR_Antagonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 579, + "assayName": "TOX21_CAR_Antagonist", + "assayDesc": "TOX21_CAR_Antagonist is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfy242", + "url": "https://pubmed.ncbi.nlm.nih.gov/30247703/", + "pmid": 30247703, + "title": "Identification of Modulators That Activate the Constitutive Androstane Receptor From the Tox21 10K Compound Library", + "author": "Lynch C, Mackowiak B, Huang R, Li L, Heyward S, Sakamuru S, Wang H, Xia M", + "citation": "Lynch C, Mackowiak B, Huang R, Li L, Heyward S, Sakamuru S, Wang H, Xia M. Identification of Modulators That Activate the Constitutive Androstane Receptor From the Tox21 10K Compound Library. Toxicol Sci. 2019 Jan 1;167(1):282-292. doi: 10.1093/toxsci/kfy242. PMID: 30247703; PMCID: PMC6657574.", + "otherId": "0", + "citationId": 272, + "otherSource": "" + } + }, + { + "aeid": 2053, + "assayComponentEndpointName": "TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4-hydroxytamoxifen", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1935, + "assayComponentName": "TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2", + "assayComponentDesc": "TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2 is one of one assay component(s) measured or calculated from the TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2 assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] are indicative of changes in transcriptional gene expression due to antagonist activity regulated by the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 580, + "assayName": "TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2", + "assayDesc": "TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2 is a cell-based, single-readout assay that uses VM7, a human breast tissue cell line, with measurements taken at 48 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 22.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfv168", + "url": "https://pubmed.ncbi.nlm.nih.gov/26272952/", + "pmid": 26272952, + "title": "Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor", + "author": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS", + "citation": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS. Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor. Toxicol Sci. 2015 Nov;148(1):137-54. doi: 10.1093/toxsci/kfv168. Epub 2015 Aug 13. PMID: 26272952; PMCID: PMC4635633.", + "otherId": "0", + "citationId": 277, + "otherSource": "" + } + }, + { + "aeid": 2054, + "assayComponentEndpointName": "TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1936, + "assayComponentName": "TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2_viability", + "assayComponentDesc": "TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 580, + "assayName": "TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2", + "assayDesc": "TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2 is a cell-based, single-readout assay that uses VM7, a human breast tissue cell line, with measurements taken at 48 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 22.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfv168", + "url": "https://pubmed.ncbi.nlm.nih.gov/26272952/", + "pmid": 26272952, + "title": "Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor", + "author": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS", + "citation": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS. Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor. Toxicol Sci. 2015 Nov;148(1):137-54. doi: 10.1093/toxsci/kfv168. Epub 2015 Aug 13. PMID: 26272952; PMCID: PMC4635633.", + "otherId": "0", + "citationId": 277, + "otherSource": "" + } + }, + { + "aeid": 2055, + "assayComponentEndpointName": "TOX21_ERR_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERR_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERR_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESRRA. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Genistein", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1937, + "assayComponentName": "TOX21_ERR_Agonist", + "assayComponentDesc": "TOX21_ERR_Agonist is one of one assay component(s) measured or calculated from the TOX21_ERR_Agonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "TOX21_ERR_Agonist was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human estrogen-related receptor alpha [GeneSymbol:ESRRA | GeneID:2101|.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 581, + "assayName": "TOX21_ERR", + "assayDesc": "TOX21_ERR is a cell-based, single-readout assay that uses ERR-HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ERR-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 119, + "geneName": "estrogen-related receptor alpha", + "description": null, + "geneSymbol": "ESRRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2101, + "officialSymbol": "ESRRA", + "officialFullName": "estrogen-related receptor alpha", + "uniprotAccessionNumber": "P11474" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2057, + "assayComponentEndpointName": "TOX21_ERR_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERR_Antagonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERR_Antagonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESRRA. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "XCT790", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1939, + "assayComponentName": "TOX21_ERR_Antagonist", + "assayComponentDesc": "TOX21_ERR_Agonist is one of one assay component(s) measured or calculated from the TOX21_ERR_Agonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "TOX21_ERR_Agonist was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human estrogen-related receptor alpha [GeneSymbol:ESRRA | GeneID:2101|.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 581, + "assayName": "TOX21_ERR", + "assayDesc": "TOX21_ERR is a cell-based, single-readout assay that uses ERR-HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ERR-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 119, + "geneName": "estrogen-related receptor alpha", + "description": null, + "geneSymbol": "ESRRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2101, + "officialSymbol": "ESRRA", + "officialFullName": "estrogen-related receptor alpha", + "uniprotAccessionNumber": "P11474" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2059, + "assayComponentEndpointName": "TOX21_ERR_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_ERR_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1941, + "assayComponentName": "TOX21_ERR_viability", + "assayComponentDesc": "TOX21_ERR_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 581, + "assayName": "TOX21_ERR", + "assayDesc": "TOX21_ERR is a cell-based, single-readout assay that uses ERR-HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ERR-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2060, + "assayComponentEndpointName": "TOX21_H2AX_HTRF_CHO_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_H2AX_HTRF_CHO_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1942, + "assayComponentName": "TOX21_H2AX_HTRF_CHO_viability", + "assayComponentDesc": "TOX21_H2AX_HTRF_CHO_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 451, + "assayName": "TOX21_H2AX_HTRF_CHO_Agonist", + "assayDesc": "TOX21_H2AX_HTRF_CHO_Agonist is a cell-based, single-readout assay that uses CHO-K1, a chinese hamster ovary cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 10029, + "organism": "chinese hamster", + "tissue": "ovary", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "CHO-K1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 2061, + "assayComponentEndpointName": "TOX21_HDAC_Inhibition", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_HDAC_Inhibition was analyzed into 1 assay endpoint. This assay endpoint, TOX21_HDAC_Inhibition, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene HDAC1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Trichostatin A", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "hydrolase", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1943, + "assayComponentName": "TOX21_HDAC_Inhibition", + "assayComponentDesc": "TOX21_HDAC_Inhibition is one of one assay component(s) measured or calculated from the TOX21_HDAC_Inhibition assay. It is designed to make measurements of HDAC activity as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "TOX21_HDAC_Inhibition was designed to target enzymatic activity specifically mapping to HDAC1 gene(s) using a positive control of Trichostatin A", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 582, + "assayName": "TOX21_HDAC_Inhibition", + "assayDesc": "TOX21_HDAC_Inhibition is a cell-based, single-readout assay that uses HCT-116, a human colon cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "colon", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 1459, + "geneName": "histone deacetylase 1", + "description": "histone deacetylase 1", + "geneSymbol": "HDAC1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 3065, + "officialSymbol": "HDAC1", + "officialFullName": "histone deacetylase 1", + "uniprotAccessionNumber": "Q13547" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057116629381", + "url": "https://pubmed.ncbi.nlm.nih.gov/26858181/", + "pmid": 26858181, + "title": "Identification of HDAC Inhibitors Using a Cell-Based HDAC I/II Assay", + "author": "Hsu CW, Shou D, Huang R, Khuc T, Dai S, Zheng W, Klumpp-Thomas C, Xia M", + "citation": "Hsu CW, Shou D, Huang R, Khuc T, Dai S, Zheng W, Klumpp-Thomas C, Xia M. Identification of HDAC Inhibitors Using a Cell-Based HDAC I/II Assay. J Biomol Screen. 2016 Jul;21(6):643-52. doi: 10.1177/1087057116629381. Epub 2016 Feb 8. PMID: 26858181; PMCID: PMC4917448.", + "otherId": "0", + "citationId": 273, + "otherSource": "" + } + }, + { + "aeid": 2062, + "assayComponentEndpointName": "TOX21_HDAC_Inhibition_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_HDAC_Inhibition_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1944, + "assayComponentName": "TOX21_HDAC_Inhibition_viability", + "assayComponentDesc": "TOX21_HDAC_Inhibition_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 582, + "assayName": "TOX21_HDAC_Inhibition", + "assayDesc": "TOX21_HDAC_Inhibition is a cell-based, single-readout assay that uses HCT-116, a human colon cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "colon", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1177/1087057116629381", + "url": "https://pubmed.ncbi.nlm.nih.gov/26858181/", + "pmid": 26858181, + "title": "Identification of HDAC Inhibitors Using a Cell-Based HDAC I/II Assay", + "author": "Hsu CW, Shou D, Huang R, Khuc T, Dai S, Zheng W, Klumpp-Thomas C, Xia M", + "citation": "Hsu CW, Shou D, Huang R, Khuc T, Dai S, Zheng W, Klumpp-Thomas C, Xia M. Identification of HDAC Inhibitors Using a Cell-Based HDAC I/II Assay. J Biomol Screen. 2016 Jul;21(6):643-52. doi: 10.1177/1087057116629381. Epub 2016 Feb 8. PMID: 26858181; PMCID: PMC4917448.", + "otherId": "0", + "citationId": 273, + "otherSource": "" + } + }, + { + "aeid": 2063, + "assayComponentEndpointName": "TOX21_HRE_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_HRE_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_HRE_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene HIF1A. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Cobalt(II)chloride hexahydrate", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1945, + "assayComponentName": "TOX21_HRE_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_HRE_BLA_Agonist_ch1 is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_HRE_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target transcription factor activity, specifically mapping to HIF1A gene(s) using a positive control of Cobalt(II)chloride hexahydrate", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 583, + "assayName": "TOX21_HRE_BLA_Agonist", + "assayDesc": "TOX21_HRE_BLA_Agonist is a cell-based, single-readout assay that uses ME-180, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ME-180", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2064, + "assayComponentEndpointName": "TOX21_HRE_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_HRE_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_HRE_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene HIF1A. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Cobalt(II)chloride hexahydrate", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1946, + "assayComponentName": "TOX21_HRE_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_HRE_BLA_Agonist_ch2 is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_HRE_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target transcription factor activity, specifically mapping to HIF1A gene(s) using a positive control of Cobalt(II)chloride hexahydrate", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 583, + "assayName": "TOX21_HRE_BLA_Agonist", + "assayDesc": "TOX21_HRE_BLA_Agonist is a cell-based, single-readout assay that uses ME-180, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ME-180", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2065, + "assayComponentEndpointName": "TOX21_HRE_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_HRE_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_HRE_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene HIF1A. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is hypoxia-response element.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Cobalt(II)chloride hexahydrate", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "hypoxia-response element", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1947, + "assayComponentName": "TOX21_HRE_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_HRE_BLA_Agonist_ratio is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_HRE_BLA_Agonist_ratio was designed to target transcription factor activity, specifically mapping to HIF1A gene(s) using a positive control of Cobalt(II)chloride hexahydrate", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 583, + "assayName": "TOX21_HRE_BLA_Agonist", + "assayDesc": "TOX21_HRE_BLA_Agonist is a cell-based, single-readout assay that uses ME-180, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ME-180", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 152, + "geneName": "hypoxia inducible factor 1, alpha subunit (basic helix-loop-helix transcription factor)", + "description": null, + "geneSymbol": "HIF1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3091, + "officialSymbol": "HIF1A", + "officialFullName": "hypoxia inducible factor 1, alpha subunit (basic helix-loop-helix transcription factor)", + "uniprotAccessionNumber": "Q16665" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2066, + "assayComponentEndpointName": "TOX21_HRE_BLA_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_HRE_BLA_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1948, + "assayComponentName": "TOX21_HRE_BLA_Agonist_viability", + "assayComponentDesc": "TOX21_HRE_BLA_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 583, + "assayName": "TOX21_HRE_BLA_Agonist", + "assayDesc": "TOX21_HRE_BLA_Agonist is a cell-based, single-readout assay that uses ME-180, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ME-180", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2067, + "assayComponentEndpointName": "TOX21_LUC_Biochem", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_LUC_Biochem used a type of viability reporter where loss-of-signal activity can be used to understand inhibition of luciferase enzymatic activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the enzyme intended target family, where the subfamily is luciferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "PTC124", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "enzyme", + "intendedTargetFamilySub": "luciferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1949, + "assayComponentName": "TOX21_LUC_Biochem", + "assayComponentDesc": "TOX21_LUC_Biochem is an assay readout measuring inhibition of luciferase enzymatic activity and designed using Km levels of luciferin and ATP. ", + "assayComponentTargetDesc": "TOX21_LUC_Biochem was designed to target enzymatic activity, specifically mapping to Firefly luciferase gene(s) using a positive control of PTC-124", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "artifact detection", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 584, + "assayName": "TOX21_LUC_Biochem", + "assayDesc": "TOX21_LUC_Biochem is a cell-free, single-readout assay that uses purified luciferase enzyme. Measurements were taken 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 7054, + "organism": "firefly", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "firefly luciferase (Fluc)", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2068, + "assayComponentEndpointName": "TOX21_PGC_ERR_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PGC_ERR_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PGC_ERR_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESRRA. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Genistein", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1950, + "assayComponentName": "TOX21_PGC_ERR_Agonist", + "assayComponentDesc": "TOX21_PGC_ERR_Agonist is one of one assay component(s) measured or calculated from the TOX21_PGC_ERR_Agonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology", + "assayComponentTargetDesc": "TOX21_PGC_ERR_Agonist was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human estrogen-related receptor alpha [GeneSymbol:ESRRA | GeneID:2101| in the presence of PGC1a expression", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 585, + "assayName": "TOX21_PGC_ERR", + "assayDesc": "TOX21_PGC_ERR is a cell-based, single-readout assay that uses PGC/ERR HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PGC/ERR HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 119, + "geneName": "estrogen-related receptor alpha", + "description": null, + "geneSymbol": "ESRRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2101, + "officialSymbol": "ESRRA", + "officialFullName": "estrogen-related receptor alpha", + "uniprotAccessionNumber": "P11474" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2070, + "assayComponentEndpointName": "TOX21_PGC_ERR_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PGC_ERR_Antagonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PGC_ERR_Antagonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESRRA. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "XCT790", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1952, + "assayComponentName": "TOX21_PGC_ERR_Antagonist", + "assayComponentDesc": "TOX21_PGC_ERR_Antagonist is one of one assay component(s) measured or calculated from the TOX21_PGC_ERR_Agonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology", + "assayComponentTargetDesc": "TOX21_PGC_ERR_Agonist was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human estrogen-related receptor alpha [GeneSymbol:ESRRA | GeneID:2101|in the presence of PGC1a expression", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 585, + "assayName": "TOX21_PGC_ERR", + "assayDesc": "TOX21_PGC_ERR is a cell-based, single-readout assay that uses PGC/ERR HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PGC/ERR HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 119, + "geneName": "estrogen-related receptor alpha", + "description": null, + "geneSymbol": "ESRRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2101, + "officialSymbol": "ESRRA", + "officialFullName": "estrogen-related receptor alpha", + "uniprotAccessionNumber": "P11474" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2072, + "assayComponentEndpointName": "TOX21_PGC_ERR_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_PGC_ERR_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1954, + "assayComponentName": "TOX21_PGC_ERR_viability", + "assayComponentDesc": "TOX21_PGC_ERR_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 585, + "assayName": "TOX21_PGC_ERR", + "assayDesc": "TOX21_PGC_ERR is a cell-based, single-readout assay that uses PGC/ERR HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PGC/ERR HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2074, + "assayComponentEndpointName": "TOX21_RT_HEK293_FLO_00hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEK293_FLO_00hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_GLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1956, + "assayComponentName": "TOX21_RT_HEK293_FLO_00hr_viability", + "assayComponentDesc": "TOX21_RT_HEK293_FLO_00hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEK293_FLO_00hr_viability. It is designed to make measurements of dead cells as detected with biofluorescent emission of fluorescent dye bound to dead cell DNA at 0 hr after exposure", + "assayComponentTargetDesc": "TOX21_RT_HEK293_FLO_00hr_viability was designed to measure changes to biofluorescent signals produced from the key cyanine dye [CellTox Green] binding to dead cell DNA. Increases are indicative of decreased viable cells present in the culture", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dead cells", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence emission", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 586, + "assayName": "TOX21_RT_HEK293", + "assayDesc": "TOX21_RT_HEK293 is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2075, + "assayComponentEndpointName": "TOX21_RT_HEK293_FLO_08hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEK293_FLO_08hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_GLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1957, + "assayComponentName": "TOX21_RT_HEK293_FLO_08hr_viability", + "assayComponentDesc": "TOX21_RT_HEK293_FLO_08hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEK293_FLO_00hr_viability. It is designed to make measurements of dead cells as detected with biofluorescent emission of fluorescent dye bound to dead cell DNA at 8 hr after exposure", + "assayComponentTargetDesc": "TOX21_RT_HEK293_FLO_08hr_viability was designed to measure changes to biofluorescent signals produced from the key cyanine dye [CellTox Green] binding to dead cell DNA. Increases are indicative of decreased viable cells present in the culture", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dead cells", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence emission", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 586, + "assayName": "TOX21_RT_HEK293", + "assayDesc": "TOX21_RT_HEK293 is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2077, + "assayComponentEndpointName": "TOX21_RT_HEK293_FLO_16hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEK293_FLO_16hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_GLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1959, + "assayComponentName": "TOX21_RT_HEK293_FLO_16hr_viability", + "assayComponentDesc": "TOX21_RT_HEK293_FLO_16hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEK293_FLO_00hr_viability. It is designed to make measurements of dead cells as detected with biofluorescent emission of fluorescent dye bound to dead cell DNA at 16 hr after exposure", + "assayComponentTargetDesc": "TOX21_RT_HEK293_FLO_16hr_viability was designed to measure changes to biofluorescent signals produced from the key cyanine dye [CellTox Green] binding to dead cell DNA. Increases are indicative of decreased viable cells present in the culture", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dead cells", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence emission", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 586, + "assayName": "TOX21_RT_HEK293", + "assayDesc": "TOX21_RT_HEK293 is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2078, + "assayComponentEndpointName": "TOX21_RT_HEK293_FLO_24hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEK293_FLO_24hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_GLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1960, + "assayComponentName": "TOX21_RT_HEK293_FLO_24hr_viability", + "assayComponentDesc": "TOX21_RT_HEK293_FLO_24hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEK293_FLO_00hr_viability. It is designed to make measurements of dead cells as detected with biofluorescent emission of fluorescent dye bound to dead cell DNA at 24 hr after exposure", + "assayComponentTargetDesc": "TOX21_RT_HEK293_FLO_24hr_viability was designed to measure changes to biofluorescent signals produced from the key cyanine dye [CellTox Green] binding to dead cell DNA. Increases are indicative of decreased viable cells present in the culture", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dead cells", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence emission", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 586, + "assayName": "TOX21_RT_HEK293", + "assayDesc": "TOX21_RT_HEK293 is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2080, + "assayComponentEndpointName": "TOX21_RT_HEK293_FLO_32hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEK293_FLO_32hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_GLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1962, + "assayComponentName": "TOX21_RT_HEK293_FLO_32hr_viability", + "assayComponentDesc": "TOX21_RT_HEK293_FLO_32hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEK293_FLO_00hr_viability. It is designed to make measurements of dead cells as detected with biofluorescent emission of fluorescent dye bound to dead cell DNA at 32 hr after exposure", + "assayComponentTargetDesc": "TOX21_RT_HEK293_FLO_32hr_viability was designed to measure changes to biofluorescent signals produced from the key cyanine dye [CellTox Green] binding to dead cell DNA. Increases are indicative of decreased viable cells present in the culture", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dead cells", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence emission", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 586, + "assayName": "TOX21_RT_HEK293", + "assayDesc": "TOX21_RT_HEK293 is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2082, + "assayComponentEndpointName": "TOX21_RT_HEK293_FLO_40hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEK293_FLO_40hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_GLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1964, + "assayComponentName": "TOX21_RT_HEK293_FLO_40hr_viability", + "assayComponentDesc": "TOX21_RT_HEK293_FLO_40hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEK293_FLO_00hr_viability. It is designed to make measurements of dead cells as detected with biofluorescent emission of fluorescent dye bound to dead cell DNA at 40 hr after exposure", + "assayComponentTargetDesc": "TOX21_RT_HEK293_FLO_40hr_viability was designed to measure changes to biofluorescent signals produced from the key cyanine dye [CellTox Green] binding to dead cell DNA. Increases are indicative of decreased viable cells present in the culture", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dead cells", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence emission", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 586, + "assayName": "TOX21_RT_HEK293", + "assayDesc": "TOX21_RT_HEK293 is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2084, + "assayComponentEndpointName": "TOX21_RT_HEK293_GLO_00hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEK293_GLO_00hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_FLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1966, + "assayComponentName": "TOX21_RT_HEK293_GLO_00hr_viability", + "assayComponentDesc": "TOX21_RT_HEK293_GLO_00hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEK293_GLO_00hr_viability assay. It is designed to make measurements of viable cells as detected with bioluminescence signal generated by NanoLuc luciferase catalysis of a profurimazine substrate which require intracellular reduction of the substrate in a viable cell. ", + "assayComponentTargetDesc": "TOX21_RT_HEK293_GLO_00hr_viability was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Profurimazine]. Changes are indicative of changes in the number of viable cells which are required for reduction of Profurimazine to a form that can be used by NanoLuc luciferase added as a detection reagent. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "metabolic activity", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "RealTime-Glo MT Cell Viability Assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NanoLuc/profurimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 586, + "assayName": "TOX21_RT_HEK293", + "assayDesc": "TOX21_RT_HEK293 is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2086, + "assayComponentEndpointName": "TOX21_RT_HEK293_GLO_08hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEK293_GLO_08hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_FLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1968, + "assayComponentName": "TOX21_RT_HEK293_GLO_08hr_viability", + "assayComponentDesc": "TOX21_RT_HEK293_GLO_08hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEK293_GLO_00hr_viability assay. It is designed to make measurements of viable cells as detected with bioluminescence signal generated by NanoLuc luciferase catalysis of a profurimazine substrate which require intracellular reduction of the substrate in a viable cell. ", + "assayComponentTargetDesc": "TOX21_RT_HEK293_GLO_08hr_viability was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Profurimazine]. Changes are indicative of changes in the number of viable cells which are required for reduction of Profurimazine to a form that can be used by NanoLuc luciferase added as a detection reagent. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "RealTime-Glo MT Cell Viability Assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NanoLuc/profurimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 586, + "assayName": "TOX21_RT_HEK293", + "assayDesc": "TOX21_RT_HEK293 is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2088, + "assayComponentEndpointName": "TOX21_RT_HEK293_GLO_16hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEK293_GLO_16hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_FLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1970, + "assayComponentName": "TOX21_RT_HEK293_GLO_16hr_viability", + "assayComponentDesc": "TOX21_RT_HEK293_GLO_16hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEK293_GLO_00hr_viability assay. It is designed to make measurements of viable cells as detected with bioluminescence signal generated by NanoLuc luciferase catalysis of a profurimazine substrate which require intracellular reduction of the substrate in a viable cell. ", + "assayComponentTargetDesc": "TOX21_RT_HEK293_GLO_16hr_viability was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Profurimazine]. Changes are indicative of changes in the number of viable cells which are required for reduction of Profurimazine to a form that can be used by NanoLuc luciferase added as a detection reagent. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "RealTime-Glo MT Cell Viability Assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NanoLuc/profurimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 586, + "assayName": "TOX21_RT_HEK293", + "assayDesc": "TOX21_RT_HEK293 is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2089, + "assayComponentEndpointName": "TOX21_RT_HEK293_GLO_24hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEK293_GLO_24hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_FLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1971, + "assayComponentName": "TOX21_RT_HEK293_GLO_24hr_viability", + "assayComponentDesc": "TOX21_RT_HEK293_GLO_24hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEK293_GLO_00hr_viability assay. It is designed to make measurements of viable cells as detected with bioluminescence signal generated by NanoLuc luciferase catalysis of a profurimazine substrate which require intracellular reduction of the substrate in a viable cell. ", + "assayComponentTargetDesc": "TOX21_RT_HEK293_GLO_24hr_viability was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Profurimazine]. Changes are indicative of changes in the number of viable cells which are required for reduction of Profurimazine to a form that can be used by NanoLuc luciferase added as a detection reagent. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "RealTime-Glo MT Cell Viability Assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NanoLuc/profurimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 586, + "assayName": "TOX21_RT_HEK293", + "assayDesc": "TOX21_RT_HEK293 is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2091, + "assayComponentEndpointName": "TOX21_RT_HEK293_GLO_32hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEK293_GLO_32hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_FLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1973, + "assayComponentName": "TOX21_RT_HEK293_GLO_32hr_viability", + "assayComponentDesc": "TOX21_RT_HEK293_GLO_32hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEK293_GLO_00hr_viability assay. It is designed to make measurements of viable cells as detected with bioluminescence signal generated by NanoLuc luciferase catalysis of a profurimazine substrate which require intracellular reduction of the substrate in a viable cell. ", + "assayComponentTargetDesc": "TOX21_RT_HEK293_GLO_32hr_viability was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Profurimazine]. Changes are indicative of changes in the number of viable cells which are required for reduction of Profurimazine to a form that can be used by NanoLuc luciferase added as a detection reagent. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "RealTime-Glo MT Cell Viability Assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NanoLuc/profurimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 586, + "assayName": "TOX21_RT_HEK293", + "assayDesc": "TOX21_RT_HEK293 is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2093, + "assayComponentEndpointName": "TOX21_RT_HEK293_GLO_40hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEK293_GLO_40hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_FLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1975, + "assayComponentName": "TOX21_RT_HEK293_GLO_40hr_viability", + "assayComponentDesc": "TOX21_RT_HEK293_GLO_40hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEK293_GLO_00hr_viability assay. It is designed to make measurements of viable cells as detected with bioluminescence signal generated by NanoLuc luciferase catalysis of a profurimazine substrate which require intracellular reduction of the substrate in a viable cell. ", + "assayComponentTargetDesc": "TOX21_RT_HEK293_GLO_40hr_viability was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Profurimazine]. Changes are indicative of changes in the number of viable cells which are required for reduction of Profurimazine to a form that can be used by NanoLuc luciferase added as a detection reagent. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "RealTime-Glo MT Cell Viability Assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NanoLuc/profurimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 586, + "assayName": "TOX21_RT_HEK293", + "assayDesc": "TOX21_RT_HEK293 is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2094, + "assayComponentEndpointName": "TOX21_RT_HEPG2_FLO_00hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEPG2_FLO_00hr_ctrl_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_GLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1976, + "assayComponentName": "TOX21_RT_HEPG2_FLO_00hr_viability", + "assayComponentDesc": "TOX21_RT_HepG2_FLO_00hr_viability is one of one assay component(s) measured or calculated from theTOX21_RT_HepG2_FLO_00hr_viability. It is designed to make measurements of dead cells as detected with biofluorescent emission of fluorescent dye bound to dead cell DNA at 0 hr after exposure", + "assayComponentTargetDesc": "TOX21_RT_HepG2_FLO_00hr_viability was designed to measure changes to biofluorescent signals produced from the key cyanine dye [CellTox Green] binding to dead cell DNA. Increases are indicative of decreased viable cells present in the culture", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dead cells", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence emission", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 587, + "assayName": "TOX21_RT_HEPG2", + "assayDesc": "TOX21_RT_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2095, + "assayComponentEndpointName": "TOX21_RT_HEPG2_FLO_08hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEPG2_FLO_08hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_GLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1977, + "assayComponentName": "TOX21_RT_HEPG2_FLO_08hr_viability", + "assayComponentDesc": "TOX21_RT_HepG2_FLO_08hr_viability is one of one assay component(s) measured or calculated from theTOX21_RT_HepG2_FLO_00hr_viability. It is designed to make measurements of dead cells as detected with biofluorescent emission of fluorescent dye bound to dead cell DNA at 8 hr after exposure", + "assayComponentTargetDesc": "TOX21_RT_HepG2_FLO_08hr_viability was designed to measure changes to biofluorescent signals produced from the key cyanine dye [CellTox Green] binding to dead cell DNA. Increases are indicative of decreased viable cells present in the culture", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dead cells", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence emission", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 587, + "assayName": "TOX21_RT_HEPG2", + "assayDesc": "TOX21_RT_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2096, + "assayComponentEndpointName": "TOX21_RT_HEPG2_FLO_16hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEPG2_FLO_16hr_ctrl_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_GLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1978, + "assayComponentName": "TOX21_RT_HEPG2_FLO_16hr_viability", + "assayComponentDesc": "TOX21_RT_HepG2_FLO_16hr_viability is one of one assay component(s) measured or calculated from theTOX21_RT_HepG2_FLO_00hr_viability. It is designed to make measurements of dead cells as detected with biofluorescent emission of fluorescent dye bound to dead cell DNA at 16 hr after exposure", + "assayComponentTargetDesc": "TOX21_RT_HepG2_FLO_16hr_viability was designed to measure changes to biofluorescent signals produced from the key cyanine dye [CellTox Green] binding to dead cell DNA. Increases are indicative of decreased viable cells present in the culture", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dead cells", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence emission", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 587, + "assayName": "TOX21_RT_HEPG2", + "assayDesc": "TOX21_RT_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2097, + "assayComponentEndpointName": "TOX21_RT_HEPG2_FLO_24hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEPG2_FLO_24hr_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_GLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1979, + "assayComponentName": "TOX21_RT_HEPG2_FLO_24hr_viability", + "assayComponentDesc": "TOX21_RT_HepG2_FLO_24hr_viability is one of one assay component(s) measured or calculated from theTOX21_RT_HepG2_FLO_00hr_viability. It is designed to make measurements of dead cells as detected with biofluorescent emission of fluorescent dye bound to dead cell DNA at 24 hr after exposure", + "assayComponentTargetDesc": "TOX21_RT_HepG2_FLO_24hr_viability was designed to measure changes to biofluorescent signals produced from the key cyanine dye [CellTox Green] binding to dead cell DNA. Increases are indicative of decreased viable cells present in the culture", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dead cells", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence emission", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 587, + "assayName": "TOX21_RT_HEPG2", + "assayDesc": "TOX21_RT_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2098, + "assayComponentEndpointName": "TOX21_RT_HEPG2_FLO_32hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEPG2_FLO_32hr_ctrl_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_GLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1980, + "assayComponentName": "TOX21_RT_HEPG2_FLO_32hr_viability", + "assayComponentDesc": "TOX21_RT_HepG2_FLO_32hr_viability is one of one assay component(s) measured or calculated from theTOX21_RT_HepG2_FLO_00hr_viability. It is designed to make measurements of dead cells as detected with biofluorescent emission of fluorescent dye bound to dead cell DNA at 32 hr after exposure", + "assayComponentTargetDesc": "TOX21_RT_HepG2_FLO_32hr_viability was designed to measure changes to biofluorescent signals produced from the key cyanine dye [CellTox Green] binding to dead cell DNA. Increases are indicative of decreased viable cells present in the culture", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dead cells", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence emission", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 587, + "assayName": "TOX21_RT_HEPG2", + "assayDesc": "TOX21_RT_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2099, + "assayComponentEndpointName": "TOX21_RT_HEPG2_FLO_40hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEPG2_FLO_40hr_ctrl_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_GLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1981, + "assayComponentName": "TOX21_RT_HEPG2_FLO_40hr_viability", + "assayComponentDesc": "TOX21_RT_HepG2_FLO_40hr_viability is one of one assay component(s) measured or calculated from theTOX21_RT_HepG2_FLO_00hr_viability. It is designed to make measurements of dead cells as detected with biofluorescent emission of fluorescent dye bound to dead cell DNA at 40 hr after exposure", + "assayComponentTargetDesc": "TOX21_RT_HepG2_FLO_40hr_viability was designed to measure changes to biofluorescent signals produced from the key cyanine dye [CellTox Green] binding to dead cell DNA. Increases are indicative of decreased viable cells present in the culture", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dead cells", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence emission", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 587, + "assayName": "TOX21_RT_HEPG2", + "assayDesc": "TOX21_RT_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2100, + "assayComponentEndpointName": "TOX21_RT_HEPG2_GLO_00hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEPG2_GLO_00hr_ctrl_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_FLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1982, + "assayComponentName": "TOX21_RT_HEPG2_GLO_00hr_viability", + "assayComponentDesc": "TOX21_RT_HEPG2_GLO_00hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEPG2_GLO_00hr_viability assay. It is designed to make measurements of viable cells as detected with bioluminescence signal generated by NanoLuc luciferase catalysis of a profurimazine substrate which require intracellular reduction of the substrate in a viable cell. ", + "assayComponentTargetDesc": "TOX21_RT_HEPG2_GLO_00hr_viability was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Profurimazine]. Changes are indicative of changes in the number of viable cells which are required for reduction of Profurimazine to a form that can be used by NanoLuc luciferase added as a detection reagent. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "metabolic activity", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "RealTime-Glo MT Cell Viability Assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NanoLuc/profurimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 587, + "assayName": "TOX21_RT_HEPG2", + "assayDesc": "TOX21_RT_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2101, + "assayComponentEndpointName": "TOX21_RT_HEPG2_GLO_08hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEPG2_GLO_08hr_ctrl_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_FLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1983, + "assayComponentName": "TOX21_RT_HEPG2_GLO_08hr_viability", + "assayComponentDesc": "TOX21_RT_HEPG2_GLO_08hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEPG2_GLO_00hr_viability assay. It is designed to make measurements of viable cells as detected with bioluminescence signal generated by NanoLuc luciferase catalysis of a profurimazine substrate which require intracellular reduction of the substrate in a viable cell. ", + "assayComponentTargetDesc": "TOX21_RT_HEPG2_GLO_08hr_viability was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Profurimazine]. Changes are indicative of changes in the number of viable cells which are required for reduction of Profurimazine to a form that can be used by NanoLuc luciferase added as a detection reagent. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "metabolic activity", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "RealTime-Glo MT Cell Viability Assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NanoLuc/profurimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 587, + "assayName": "TOX21_RT_HEPG2", + "assayDesc": "TOX21_RT_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2102, + "assayComponentEndpointName": "TOX21_RT_HEPG2_GLO_16hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEPG2_GLO_16hr_ctrl_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_FLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1984, + "assayComponentName": "TOX21_RT_HEPG2_GLO_16hr_viability", + "assayComponentDesc": "TOX21_RT_HEPG2_GLO_16hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEPG2_GLO_00hr_viability assay. It is designed to make measurements of viable cells as detected with bioluminescence signal generated by NanoLuc luciferase catalysis of a profurimazine substrate which require intracellular reduction of the substrate in a viable cell. ", + "assayComponentTargetDesc": "TOX21_RT_HEPG2_GLO_16hr_viability was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Profurimazine]. Changes are indicative of changes in the number of viable cells which are required for reduction of Profurimazine to a form that can be used by NanoLuc luciferase added as a detection reagent. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "metabolic activity", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "RealTime-Glo MT Cell Viability Assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NanoLuc/profurimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 587, + "assayName": "TOX21_RT_HEPG2", + "assayDesc": "TOX21_RT_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2103, + "assayComponentEndpointName": "TOX21_RT_HEPG2_GLO_32hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEPG2_GLO_32hr_ctrl_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_FLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1985, + "assayComponentName": "TOX21_RT_HEPG2_GLO_32hr_viability", + "assayComponentDesc": "TOX21_RT_HEPG2_GLO_32hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEPG2_GLO_00hr_viability assay. It is designed to make measurements of viable cells as detected with bioluminescence signal generated by NanoLuc luciferase catalysis of a profurimazine substrate which require intracellular reduction of the substrate in a viable cell. ", + "assayComponentTargetDesc": "TOX21_RT_HEPG2_GLO_32hr_viability was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Profurimazine]. Changes are indicative of changes in the number of viable cells which are required for reduction of Profurimazine to a form that can be used by NanoLuc luciferase added as a detection reagent. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "metabolic activity", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "RealTime-Glo MT Cell Viability Assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NanoLuc/profurimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 587, + "assayName": "TOX21_RT_HEPG2", + "assayDesc": "TOX21_RT_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2105, + "assayComponentEndpointName": "TOX21_RT_HEPG2_GLO_40hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEPG2_GLO_40hr_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1987, + "assayComponentName": "TOX21_RT_HEPG2_GLO_40hr_viability", + "assayComponentDesc": "TOX21_RT_HEPG2_GLO_40hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEPG2_GLO_00hr_viability assay. It is designed to make measurements of viable cells as detected with bioluminescence signal generated by NanoLuc luciferase catalysis of a profurimazine substrate which require intracellular reduction of the substrate in a viable cell. ", + "assayComponentTargetDesc": "TOX21_RT_HEPG2_GLO_40hr_viability was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Profurimazine]. Changes are indicative of changes in the number of viable cells which are required for reduction of Profurimazine to a form that can be used by NanoLuc luciferase added as a detection reagent. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "metabolic activity", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "RealTime-Glo MT Cell Viability Assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NanoLuc/profurimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 587, + "assayName": "TOX21_RT_HEPG2", + "assayDesc": "TOX21_RT_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2106, + "assayComponentEndpointName": "TOX21_SHH_3T3_GLI3_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_SHH_3T3_GLI3_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_SHH_3T3_GLI3_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene GLI3. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "SAG", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "zinc finger", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1988, + "assayComponentName": "TOX21_SHH_3T3_GLI3_Agonist", + "assayComponentDesc": "TOX21_SHH_3T3_GLI3_Agonist is one of one assay component(s) measured or calculated from the TOX21_SHH_3T3_GLI3_Agonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "TOX21_SHH_3T3_GLI3_Agonist was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by Gli3, part of the sonic hedgehog (Shh) pathway", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 588, + "assayName": "TOX21_SHH_3T3_GLI3_Agonist", + "assayDesc": "TOX21_SHH_3T3_GLI3_Agonist is a cell-based, single-readout assay that uses NIH/3T3, a mouse embryo cell line, with measurements taken at 24 hours after chemical dosing in a 1536 well.", + "timepointHr": 24.0, + "organismId": 10090, + "organism": "mouse", + "tissue": "embryo", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "NIH/3T3", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 6390, + "geneName": "sonic hedgehog", + "description": null, + "geneSymbol": "SHH", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 6469, + "officialSymbol": "SHH", + "officialFullName": "sonic hedgehog", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00228", + "url": "https://pubmed.ncbi.nlm.nih.gov/31652400/", + "pmid": 31652400, + "title": "Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway", + "author": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M", + "citation": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M. Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway. Chem Res Toxicol. 2019 Dec 16;32(12):2433-2444. doi: 10.1021/acs.chemrestox.9b00228. Epub 2019 Nov 11. PMID: 31652400; PMCID: PMC7341485.", + "otherId": "0", + "citationId": 282, + "otherSource": "" + } + }, + { + "aeid": 2107, + "assayComponentEndpointName": "TOX21_SHH_3T3_GLI3_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_SHH_3T3_GLI3_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1989, + "assayComponentName": "TOX21_SHH_3T3_GLI3_Agonist_viability", + "assayComponentDesc": "TOX21_SHH_3T3_GLI3_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 588, + "assayName": "TOX21_SHH_3T3_GLI3_Agonist", + "assayDesc": "TOX21_SHH_3T3_GLI3_Agonist is a cell-based, single-readout assay that uses NIH/3T3, a mouse embryo cell line, with measurements taken at 24 hours after chemical dosing in a 1536 well.", + "timepointHr": 24.0, + "organismId": 10090, + "organism": "mouse", + "tissue": "embryo", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "NIH/3T3", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00228", + "url": "https://pubmed.ncbi.nlm.nih.gov/31652400/", + "pmid": 31652400, + "title": "Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway", + "author": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M", + "citation": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M. Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway. Chem Res Toxicol. 2019 Dec 16;32(12):2433-2444. doi: 10.1021/acs.chemrestox.9b00228. Epub 2019 Nov 11. PMID: 31652400; PMCID: PMC7341485.", + "otherId": "0", + "citationId": 282, + "otherSource": "" + } + }, + { + "aeid": 2108, + "assayComponentEndpointName": "TOX21_SHH_3T3_GLI3_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_SHH_3T3_GLI3_Antagonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_SHH_3T3_GLI3_Antagonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene GLI3. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Cyclopamine", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "zinc finger", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1990, + "assayComponentName": "TOX21_SHH_3T3_GLI3_Antagonist", + "assayComponentDesc": "TOX21_SHH_3T3_GLI3_Antagonist is one of one assay component(s) measured or calculated from the TOX21_SHH_3T3_GLI3_Antagonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "TOX21_SHH_3T3_GLI3_Antagonist was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to antagonism of Gli3 activation using conditioned medium, part of the sonic hedgehog (Shh) pathway", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 589, + "assayName": "TOX21_SHH_3T3_GLI3_Antagonist", + "assayDesc": "TOX21_SHH_3T3_GLI3_Antagonist is a cell-based, single-readout assay that uses NIH/3T3, a mouse embryo cell line, with measurements taken at 24 hours after chemical dosing in a 1536 well.", + "timepointHr": 24.0, + "organismId": 10090, + "organism": "mouse", + "tissue": "embryo", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "NIH/3T3", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 6390, + "geneName": "sonic hedgehog", + "description": null, + "geneSymbol": "SHH", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 6469, + "officialSymbol": "SHH", + "officialFullName": "sonic hedgehog", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00228", + "url": "https://pubmed.ncbi.nlm.nih.gov/31652400/", + "pmid": 31652400, + "title": "Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway", + "author": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M", + "citation": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M. Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway. Chem Res Toxicol. 2019 Dec 16;32(12):2433-2444. doi: 10.1021/acs.chemrestox.9b00228. Epub 2019 Nov 11. PMID: 31652400; PMCID: PMC7341485.", + "otherId": "0", + "citationId": 282, + "otherSource": "" + } + }, + { + "aeid": 2109, + "assayComponentEndpointName": "TOX21_SHH_3T3_GLI3_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_SHH_3T3_GLI3_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1991, + "assayComponentName": "TOX21_SHH_3T3_GLI3_Antagonist_viability", + "assayComponentDesc": "TOX21_SHH_3T3_GLI3_Antagonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 589, + "assayName": "TOX21_SHH_3T3_GLI3_Antagonist", + "assayDesc": "TOX21_SHH_3T3_GLI3_Antagonist is a cell-based, single-readout assay that uses NIH/3T3, a mouse embryo cell line, with measurements taken at 24 hours after chemical dosing in a 1536 well.", + "timepointHr": 24.0, + "organismId": 10090, + "organism": "mouse", + "tissue": "embryo", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "NIH/3T3", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00228", + "url": "https://pubmed.ncbi.nlm.nih.gov/31652400/", + "pmid": 31652400, + "title": "Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway", + "author": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M", + "citation": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M. Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway. Chem Res Toxicol. 2019 Dec 16;32(12):2433-2444. doi: 10.1021/acs.chemrestox.9b00228. Epub 2019 Nov 11. PMID: 31652400; PMCID: PMC7341485.", + "otherId": "0", + "citationId": 282, + "otherSource": "" + } + }, + { + "aeid": 2110, + "assayComponentEndpointName": "CPHEA_Stoker_NIS_Cytotoxicity", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CPHEA_Stoker_NIS_Cytotoxicity was analyzed at the endpoint, CPHEA_Stoker_NIS_Cytotoxicity, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, measures of ATP content for loss-of-signal activity can be used to understand the viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "b-naphthoquinone", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1992, + "assayComponentName": "CPHEA_Stoker_NIS_Cytotoxicity", + "assayComponentDesc": "CPHEA_Stoker_NIS_Cytotoxicity is one of 2 assay components measured from the CPHEA_Stoker_NIS assay. It is designed to make measurements of atp content, a form of viability reporter, as detected with bioluminescence signals by Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo Fluor] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Luciferase", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 574, + "assayName": "CPHEA_Stoker_NIS", + "assayDesc": "CPHEA_Stoker_NIS is a cell-based, single-readout assay that uses hNIS-HEK293T-EPA, a novel human kidney cell line expressing human NIS, with measurements taken at 2 hours after chemical dosing in a 96-well plate. This radioactive iodide uptake (RAIU) assay is used to identify inhibitors of NIS-mediated iodide uptake. A parallel cytoxicity assay (Cell Titer Glo, Promega) was also run in the same cell line.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": null, + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 21, + "assaySourceName": "CPHEA_STOKER", + "assaySourceLongName": "CPHEA Stoker and Laws Labs", + "assaySourceDesc": "The Stoker and Laws laboratories at the EPA Center for Public Health and Environmental Assessment work on the development and implementation of high-throughput assays, particularly related to the sodium-iodide cotransporter (NIS).", + "gene": null, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1007/s00204-021-03006-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33656581/", + "pmid": 33656581, + "title": "Expanded high-throughput screening and chemotype-enrichment analysis of the phase II: e1k ToxCast library for human sodium-iodide symporter (NIS) inhibition", + "author": "Wang J, Richard AM, Murr AS, Buckalew AR, Lougee RR, Shobair M, Hallinger DR, Laws SC, Stoker TE", + "citation": "Wang J, Richard AM, Murr AS, Buckalew AR, Lougee RR, Shobair M, Hallinger DR, Laws SC, Stoker TE. Expanded high-throughput screening and chemotype-enrichment analysis of the phase II: e1k ToxCast library for human sodium-iodide symporter (NIS) inhibition. Arch Toxicol. 2021 May;95(5):1723-1737. doi: 10.1007/s00204-021-03006-2. Epub 2021 Mar 3. PMID: 33656581.", + "otherId": "0", + "citationId": 241, + "otherSource": "" + } + }, + { + "aeid": 2113, + "assayComponentEndpointName": "TOX21_ERb_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERb_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERb_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR2. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1999, + "assayComponentName": "TOX21_ERb_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_ERb_BLA_Agonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ERb_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to ESR2 gene(s) using a positive control of 17b-estradiol", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 593, + "assayName": "TOX21_ERb_BLA_Agonist", + "assayDesc": "TOX21_ERb_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2114, + "assayComponentEndpointName": "TOX21_ERb_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERb_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERb_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR2. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2000, + "assayComponentName": "TOX21_ERb_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_ERb_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ERb_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to ESR2 gene(s) using a positive control of 17b-estradiol", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 593, + "assayName": "TOX21_ERb_BLA_Agonist", + "assayDesc": "TOX21_ERb_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1134, + "assayComponentEndpointName": "TOX21_DT40", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_DT40 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_DT40, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in the viability. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tetraoctyl ammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "DNA repair", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 721, + "assayComponentName": "TOX21_DT40", + "assayComponentDesc": "TOX21_DT40 is an assay readout measuring cellular ATP content as a determinant of cell viability using CellTiter-Glo Luciferase-coupled ATP quantitation", + "assayComponentTargetDesc": "TOX21_DT40 assay was designed to target cell cycle (cytotoxicity) activity at the cellular (cellular) level in isogenic wildtype cells using a positive control of tetraoctylammonium bromide. Results from the wild-type cells can be compared to TOX21_DT40_100 (aeid 2130) and TOX21_DT40_657 (aeid 2131) isogenic cell line assays which contain DNA repair enzyme deletions to detect DNA-damaging agents", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 382, + "assayName": "TOX21_DT40", + "assayDesc": "TOX21_DT40 is a cell-based, single-readout assay that uses DT40, a chicken lymphoblast cell line, with measurements taken at 40 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 40.0, + "organismId": 9031, + "organism": "chicken", + "tissue": "lymphoblast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "DT40", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1136, + "assayComponentEndpointName": "LTEA_HepaRG_LDH_cytotoxicity", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_LDH_cytotoxicity was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_LDH_cytotoxicity, was analyzed in the positive fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for loss-of-signal activity can be used to understand cell death. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is proliferation.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 722, + "assayComponentName": "LTEA_HepaRG_LDH_cytotoxicity", + "assayComponentDesc": "LTEA_HepaRG_LDH_cytotoxicity is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of cell viability / cytotoxicity.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dehydrogenase activity determination", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Enzyme activity", + "keyAssayReagentType": "substrate", + "keyAssayReagent": null, + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1185, + "assayComponentEndpointName": "TOX21_ARE_BLA_agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_ARE_BLA_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 747, + "assayComponentName": "TOX21_ARE_BLA_agonist_viability", + "assayComponentDesc": "TOX21_ARE_BLA_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 372, + "assayName": "TOX21_ARE_BLA_Agonist", + "assayDesc": "TOX21_ARE_BLA_Agonist is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": " doi: 10.1289/EHP2589", + "url": "https://pubmed.ncbi.nlm.nih.gov/30059008/", + "pmid": 30059008, + "title": "Comprehensive Analyses and Prioritization of Tox21 10K Chemicals Affecting Mitochondrial Function by in-Depth Mechanistic Studies", + "author": "Xia M, Huang R, Shi Q, Boyd WA, Zhao J, Sun N, Rice JR, Dunlap PE, Hackstadt AJ, Bridge MF, Smith MV, Dai S, Zheng W, Chu PH, Gerhold D, Witt KL, DeVito M, Freedman JH, Austin CP, Houck KA, Thomas RS, Paules RS, Tice RR, Simeonov A", + "citation": "Xia M, Huang R, Shi Q, Boyd WA, Zhao J, Sun N, Rice JR, Dunlap PE, Hackstadt AJ, Bridge MF, Smith MV, Dai S, Zheng W, Chu PH, Gerhold D, Witt KL, DeVito M, Freedman JH, Austin CP, Houck KA, Thomas RS, Paules RS, Tice RR, Simeonov A. Comprehensive Analyses and Prioritization of Tox21 10K Chemicals Affecting Mitochondrial Function by in-Depth Mechanistic Studies. Environ Health Perspect. 2018 Jul 26;126(7):077010. doi: 10.1289/EHP2589. PMID: 30059008; PMCID: PMC6112376.", + "otherId": "0", + "citationId": 275, + "otherSource": "" + } + }, + { + "aeid": 1186, + "assayComponentEndpointName": "TOX21_HSE_BLA_agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_HSE_BLA_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 748, + "assayComponentName": "TOX21_HSE_BLA_agonist_viability", + "assayComponentDesc": "TOX21_HSE_BLA_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 373, + "assayName": "TOX21_HSE_BLA_Agonist", + "assayDesc": "TOX21_HSE_BLA_Agonist is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 1187, + "assayComponentEndpointName": "TOX21_p53_BLA_p1_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_p53_BLA_p1_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 749, + "assayComponentName": "TOX21_p53_BLA_p1_viability", + "assayComponentDesc": "TOX21_p53_BLA_p1_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 374, + "assayName": "TOX21_p53_BLA_p1", + "assayDesc": "TOX21_p53_BLA_p1 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1188, + "assayComponentEndpointName": "TOX21_FXR_BLA_agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_FXR_BLA_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 750, + "assayComponentName": "TOX21_FXR_BLA_agonist_viability", + "assayComponentDesc": "TOX21_FXR_BLA_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 375, + "assayName": "TOX21_FXR_BLA_Agonist", + "assayDesc": "TOX21_FXR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1189, + "assayComponentEndpointName": "TOX21_ERa_BLA_Antagonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERa_BLA_Antagonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERa_BLA_Antagonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene ESR1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4-hydroxytamoxifen", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 751, + "assayComponentName": "TOX21_ERa_BLA_Antagonist_ch1", + "assayComponentDesc": "TOX21_ERa_BLA_Antagonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ERa_BLA_Antagonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to ESR1 gene(s) using a positive control of 4-hydroxytamoxifen", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 319, + "assayName": "TOX21_ERa_BLA_Antagonist", + "assayDesc": "TOX21_ERa_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1190, + "assayComponentEndpointName": "TOX21_ERa_BLA_Antagonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERa_BLA_Antagonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERa_BLA_Antagonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4-hydroxytamoxifen", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 752, + "assayComponentName": "TOX21_ERa_BLA_Antagonist_ch2", + "assayComponentDesc": "TOX21_ERa_BLA_Antagonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ERa_BLA_Antagonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor (steroidal) activity at the protein (receptor) level, specifically mapping to ESR1 gene(s) using a positive control of 4-hydroxytamoxifen", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 319, + "assayName": "TOX21_ERa_BLA_Antagonist", + "assayDesc": "TOX21_ERa_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1191, + "assayComponentEndpointName": "TOX21_FXR_BLA_Antagonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_FXR_BLA_Antagonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_FXR_BLA_Antagonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter,increased activity can be used to understand changes in the reporter gene as they relate to the gene NR1H4. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Guggulsterone", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 753, + "assayComponentName": "TOX21_FXR_BLA_Antagonist_ch1", + "assayComponentDesc": "TOX21_FXR_BLA_Antagonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_FXR_BLA_Antagonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR1H4 gene(s) using a positive control of Guggulsterone", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 376, + "assayName": "TOX21_FXR_BLA_Antagonist", + "assayDesc": "TOX21_FXR_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1192, + "assayComponentEndpointName": "TOX21_FXR_BLA_Antagonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_FXR_BLA_Antagonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_FXR_BLA_Antagonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR1H4. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Guggulsterone", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 754, + "assayComponentName": "TOX21_FXR_BLA_Antagonist_ch2", + "assayComponentDesc": "TOX21_FXR_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_FXR_BLA_Antagonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR1H4 gene(s) using a positive control of Guggulsterone", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 376, + "assayName": "TOX21_FXR_BLA_Antagonist", + "assayDesc": "TOX21_FXR_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1193, + "assayComponentEndpointName": "TOX21_GR_BLA_Antagonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_GR_BLA_Antagonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_GR_BLA_Antagonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene NR3C1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mifepristone", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 755, + "assayComponentName": "TOX21_GR_BLA_Antagonist_ch1", + "assayComponentDesc": "TOX21_GR_BLA_Antagonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_GR_BLA_Antagonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR3C1 gene(s) using a positive control of Mifepristone", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 323, + "assayName": "TOX21_GR_BLA_Antagonist", + "assayDesc": "TOX21_GR_BLA_Antagonist is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1194, + "assayComponentEndpointName": "TOX21_GR_BLA_Antagonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_GR_BLA_Antagonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_GR_BLA_Antagonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR3C1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mifepristone", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 756, + "assayComponentName": "TOX21_GR_BLA_Antagonist_ch2", + "assayComponentDesc": "TOX21_GR_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_GR_BLA_Antagonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor (non-steroidal) activity at the protein (receptor) level, specifically mapping to NR3C1 gene(s) using a positive control of Mifepristone", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 323, + "assayName": "TOX21_GR_BLA_Antagonist", + "assayDesc": "TOX21_GR_BLA_Antagonist is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1195, + "assayComponentEndpointName": "TOX21_PPARd_BLA_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_PPARd_BLA_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 757, + "assayComponentName": "TOX21_PPARd_BLA_Agonist_viability", + "assayComponentDesc": "TOX21_PPARd_BLA_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 377, + "assayName": "TOX21_PPARd_BLA_Agonist", + "assayDesc": "TOX21_PPARd_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1196, + "assayComponentEndpointName": "TOX21_PPARd_BLA_Antagonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PPARd_BLA_Antagonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PPARd_BLA_Antagonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter,increased activity can be used to understand changes in the reporter gene as they relate to the gene PPARD. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "MK886", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 758, + "assayComponentName": "TOX21_PPARd_BLA_Antagonist_ch1", + "assayComponentDesc": "TOX21_PPARd_BLA_Antagonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_PPARD_BLA_Antagonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to PPARD gene(s) using a positive control of MK886", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 378, + "assayName": "TOX21_PPARd_BLA_Antagonist", + "assayDesc": "TOX21_PPARd_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1197, + "assayComponentEndpointName": "TOX21_PPARd_BLA_Antagonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PPARd_BLA_Antagonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PPARd_BLA_Antagonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene PPARD. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "MK886", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 759, + "assayComponentName": "TOX21_PPARd_BLA_Antagonist_ch2", + "assayComponentDesc": "TOX21_PPARd_BLA_Antagonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_PPARD_BLA_Antagonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to PPARD gene(s) using a positive control of MK886", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 378, + "assayName": "TOX21_PPARd_BLA_Antagonist", + "assayDesc": "TOX21_PPARd_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1198, + "assayComponentEndpointName": "TOX21_PPARg_BLA_Antagonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PPARg_BLA_Antagonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PPARg_BLA_Antagonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter,increased activity can be used to understand changes in the reporter gene as they relate to the gene PPARG. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GW9662", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 760, + "assayComponentName": "TOX21_PPARg_BLA_Antagonist_ch1", + "assayComponentDesc": "TOX21_PPARg_BLA_Antagonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_PPARg_BLA_Antagonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to PPARG gene(s) using a positive control of GW9662", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 379, + "assayName": "TOX21_PPARg_BLA_Antagonist", + "assayDesc": "TOX21_PPARg_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1199, + "assayComponentEndpointName": "TOX21_PPARg_BLA_Antagonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PPARg_BLA_Antagonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PPARg_BLA_Antagonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene PPARG. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GW9662", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 761, + "assayComponentName": "TOX21_PPARg_BLA_Antagonist_ch2", + "assayComponentDesc": "TOX21_PPARg_BLA_Antagonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_PPARg_BLA_Antagonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to PPARG gene(s) using a positive control of GW9662", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 379, + "assayName": "TOX21_PPARg_BLA_Antagonist", + "assayDesc": "TOX21_PPARg_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1200, + "assayComponentEndpointName": "TOX21_VDR_BLA_Antagonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_VDR_BLA_Antagonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_VDR_BLA_Antagonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter,increased activity can be used to understand changes in the reporter gene as they relate to the gene CYP24A1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tetraoctyl ammonium bromide", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 762, + "assayComponentName": "TOX21_VDR_BLA_Antagonist_ch1", + "assayComponentDesc": "TOX21_VDR_BLA_Antagonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_VDR_BLA_Antagonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR1I1 gene(s) using a positive control of Tetraoctyl ammonium bromide", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 381, + "assayName": "TOX21_VDR_BLA_Antagonist", + "assayDesc": "TOX21_VDR_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-018-27055-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/29891985/", + "pmid": 29891985, + "title": "Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays", + "author": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW", + "citation": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW. Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays. Sci Rep. 2018 Jun 11;8(1):8883. doi: 10.1038/s41598-018-27055-3. PMID: 29891985; PMCID: PMC5995905.", + "otherId": "0", + "citationId": 270, + "otherSource": "" + } + }, + { + "aeid": 1201, + "assayComponentEndpointName": "TOX21_VDR_BLA_Antagonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_VDR_BLA_Antagonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_VDR_BLA_Antagonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP24A1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1alpha,25-Dihydroxy vitamin D3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 763, + "assayComponentName": "TOX21_VDR_BLA_Antagonist_ch2", + "assayComponentDesc": "TOX21_VDR_BLA_Antagonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_VDR_BLA_Antagonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR1I1 gene(s) using a positive control of Tetraoctyl ammonium bromide", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 381, + "assayName": "TOX21_VDR_BLA_Antagonist", + "assayDesc": "TOX21_VDR_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-018-27055-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/29891985/", + "pmid": 29891985, + "title": "Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays", + "author": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW", + "citation": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW. Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays. Sci Rep. 2018 Jun 11;8(1):8883. doi: 10.1038/s41598-018-27055-3. PMID: 29891985; PMCID: PMC5995905.", + "otherId": "0", + "citationId": 270, + "otherSource": "" + } + }, + { + "aeid": 1202, + "assayComponentEndpointName": "TOX21_AR_BLA_Antagonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AR_BLA_Antagonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AR_BLA_Antagonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter,increased activity can be used to understand changes in the reporter gene as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Cyproterone acetate", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 764, + "assayComponentName": "TOX21_AR_BLA_Antagonist_ch1", + "assayComponentDesc": "TOX21_AR_BLA_Antagonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_AR_BLA_Antagonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to AR gene(s) using a positive control of Cyproterone acetate", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 311, + "assayName": "TOX21_AR_BLA_Antagonist", + "assayDesc": "TOX21_AR_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 2115, + "assayComponentEndpointName": "TOX21_ERb_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERb_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERb_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR2. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2001, + "assayComponentName": "TOX21_ERb_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_ERb_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ERb_BLA_Agonist_ch2 was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to ESR2 gene(s) using a positive control of 17b-estradiol", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 593, + "assayName": "TOX21_ERb_BLA_Agonist", + "assayDesc": "TOX21_ERb_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 118, + "geneName": "estrogen receptor 2 (ER beta)", + "description": null, + "geneSymbol": "ESR2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2100, + "officialSymbol": "ESR2", + "officialFullName": "estrogen receptor 2 (ER beta)", + "uniprotAccessionNumber": "Q92731" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2116, + "assayComponentEndpointName": "TOX21_ERb_BLA_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_ERb_BLA_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2002, + "assayComponentName": "TOX21_ERb_BLA_Agonist_viability", + "assayComponentDesc": "TOX21_ERb_BLA_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 593, + "assayName": "TOX21_ERb_BLA_Agonist", + "assayDesc": "TOX21_ERb_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2117, + "assayComponentEndpointName": "TOX21_ERb_BLA_Antagonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERb_BLA_Antagonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERb_BLA_Antagonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene ESR2. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4-hydroxytamoxifen", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1995, + "assayComponentName": "TOX21_ERb_BLA_Antagonist_ch1", + "assayComponentDesc": "TOX21_ERb_BLA_Antagonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ERb_BLA_Antagonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to ESR2 gene(s) using a positive control of 4-hydroxytamoxifen", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 592, + "assayName": "TOX21_ERb_BLA_Antagonist", + "assayDesc": "TOX21_ERb_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2118, + "assayComponentEndpointName": "TOX21_ERb_BLA_Antagonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERb_BLA_Antagonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERb_BLA_Antagonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR2. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4-hydroxytamoxifen", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1996, + "assayComponentName": "TOX21_ERb_BLA_Antagonist_ch2", + "assayComponentDesc": "TOX21_ERb_BLA_Antagonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ERb_BLA_Antagonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to ESR2 gene(s) using a positive control of 4-hydroxytamoxifen", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 592, + "assayName": "TOX21_ERb_BLA_Antagonist", + "assayDesc": "TOX21_ERb_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2119, + "assayComponentEndpointName": "TOX21_ERb_BLA_Antagonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERb_BLA_Antagonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERb_BLA_Antagonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR2. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4-hydroxytamoxifen", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1997, + "assayComponentName": "TOX21_ERb_BLA_Antagonist_ratio", + "assayComponentDesc": "TOX21_ERb_BLA_Antagonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ERb_BLA_Antagonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to ESR2 gene(s) using a positive control of 4-hydroxytamoxifen", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 592, + "assayName": "TOX21_ERb_BLA_Antagonist", + "assayDesc": "TOX21_ERb_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 118, + "geneName": "estrogen receptor 2 (ER beta)", + "description": null, + "geneSymbol": "ESR2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2100, + "officialSymbol": "ESR2", + "officialFullName": "estrogen receptor 2 (ER beta)", + "uniprotAccessionNumber": "Q92731" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2120, + "assayComponentEndpointName": "TOX21_ERb_BLA_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_ERb_BLA_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1998, + "assayComponentName": "TOX21_ERb_BLA_Antagonist_viability", + "assayComponentDesc": "TOX21_ERb_BLA_Antagonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 592, + "assayName": "TOX21_ERb_BLA_Antagonist", + "assayDesc": "TOX21_ERb_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2121, + "assayComponentEndpointName": "TOX21_PR_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "promegestone (R5020)", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2003, + "assayComponentName": "TOX21_PR_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_PR_BLA_Agonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Progesterone receptor (PR), a nuclear hormone receptor, plays an important role in development, metabolic homeostasis and reproduction. It is activated by the steroid hormone progesterone. Endocrine disrupting chemicals (EDCs) and their interactions with steroid hormone receptors like PR causes disruption of normal endocrine function. ", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 594, + "assayName": "TOX21_PR_BLA_Agonist", + "assayDesc": "TOX21_PR_BLA_Agonist is a cell-based, single-readout assay that uses transfected HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2122, + "assayComponentEndpointName": "TOX21_PR_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "promegestone (R5020)", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2004, + "assayComponentName": "TOX21_PR_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_PR_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Progesterone receptor (PR), a nuclear hormone receptor, plays an important role in development, metabolic homeostasis and reproduction. It is activated by the steroid hormone progesterone. Endocrine disrupting chemicals (EDCs) and their interactions with steroid hormone receptors like PR causes disruption of normal endocrine function. ", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 594, + "assayName": "TOX21_PR_BLA_Agonist", + "assayDesc": "TOX21_PR_BLA_Agonist is a cell-based, single-readout assay that uses transfected HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2123, + "assayComponentEndpointName": "TOX21_PR_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand the reporter gene at the pathway-level as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "promegestone (R5020)", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2005, + "assayComponentName": "TOX21_PR_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_PR_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "Progesterone receptor (PR), a nuclear hormone receptor, plays an important role in development, metabolic homeostasis and reproduction. It is activated by the steroid hormone progesterone. Endocrine disrupting chemicals (EDCs) and their interactions with steroid hormone receptors like PR causes disruption of normal endocrine function. ", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 594, + "assayName": "TOX21_PR_BLA_Agonist", + "assayDesc": "TOX21_PR_BLA_Agonist is a cell-based, single-readout assay that uses transfected HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2124, + "assayComponentEndpointName": "TOX21_PR_BLA_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_PR_BLA_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2006, + "assayComponentName": "TOX21_PR_BLA_Agonist_viability", + "assayComponentDesc": "TOX21_PR_BLA_Agonist_viability is a component of the TOX21_PR_BLA_Agonist assay. This component measures cell viability using the CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 594, + "assayName": "TOX21_PR_BLA_Agonist", + "assayDesc": "TOX21_PR_BLA_Agonist is a cell-based, single-readout assay that uses transfected HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2125, + "assayComponentEndpointName": "TOX21_PR_BLA_Antagonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_BLA_Antagonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_BLA_Antagonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "RU486", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2007, + "assayComponentName": "TOX21_PR_BLA_Antagonist_ch1", + "assayComponentDesc": "TOX21_PR_BLA_Antagonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Progesterone receptor (PR), a nuclear hormone receptor, plays an important role in development, metabolic homeostasis and reproduction. It is activated by the steroid hormone progesterone. Endocrine disrupting chemicals (EDCs) and their interactions with steroid hormone receptors like PR causes disruption of normal endocrine function. ", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 595, + "assayName": "TOX21_PR_BLA_Antagonist", + "assayDesc": "TOX21_PR_BLA_Antagonist is a cell-based, single-readout assay that uses transfected HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2126, + "assayComponentEndpointName": "TOX21_PR_BLA_Antagonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_BLA_Antagonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_BLA_Antagonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "RU486", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2008, + "assayComponentName": "TOX21_PR_BLA_Antagonist_ch2", + "assayComponentDesc": "TOX21_PR_BLA_Antagonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Progesterone receptor (PR), a nuclear hormone receptor, plays an important role in development, metabolic homeostasis and reproduction. It is activated by the steroid hormone progesterone. Endocrine disrupting chemicals (EDCs) and their interactions with steroid hormone receptors like PR causes disruption of normal endocrine function. ", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 595, + "assayName": "TOX21_PR_BLA_Antagonist", + "assayDesc": "TOX21_PR_BLA_Antagonist is a cell-based, single-readout assay that uses transfected HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2127, + "assayComponentEndpointName": "TOX21_PR_BLA_Antagonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_BLA_Antagonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_BLA_Antagonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity an be used to understand changes in the reporter gene as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "RU486", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2009, + "assayComponentName": "TOX21_PR_BLA_Antagonist_ratio", + "assayComponentDesc": "TOX21_PR_BLA_Antagonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "Progesterone receptor (PR), a nuclear hormone receptor, plays an important role in development, metabolic homeostasis and reproduction. It is activated by the steroid hormone progesterone. Endocrine disrupting chemicals (EDCs) and their interactions with steroid hormone receptors like PR causes disruption of normal endocrine function. ", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 595, + "assayName": "TOX21_PR_BLA_Antagonist", + "assayDesc": "TOX21_PR_BLA_Antagonist is a cell-based, single-readout assay that uses transfected HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2128, + "assayComponentEndpointName": "TOX21_PR_BLA_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_PR_BLA_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2010, + "assayComponentName": "TOX21_PR_BLA_Antagonist_viability", + "assayComponentDesc": "TOX21_PR_BLA_Antagonist_viability is a component of the TOX21_PR_BLA_Antagonist assay. This component measures cell viability using the CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 595, + "assayName": "TOX21_PR_BLA_Antagonist", + "assayDesc": "TOX21_PR_BLA_Antagonist is a cell-based, single-readout assay that uses transfected HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2130, + "assayComponentEndpointName": "TOX21_DT40_100", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_DT40_100 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_DT40_100, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in the viability as they relate to the gene Ku70 - Rad54 (-/-). Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the DNA repair family.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tetraoctyl ammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "DNA repair", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2012, + "assayComponentName": "TOX21_DT40_100", + "assayComponentDesc": "TOX21_DT40_100 is an assay readout measuring cellular ATP content as a determinant of cell viability using CellTiter-Glo Luciferase-coupled ATP quantitation", + "assayComponentTargetDesc": "TOX21_DT40_100 assay was designed to target cell cycle (cytotoxicity) activity at the cellular (cellular) level, specifically mapping to Ku70 and Rad54 gene(s) using a positive control of tetraoctylammonium bromide. The DT40_100 cells have Ku70 and Rad54 gene deletions (-/-) which are involved in reparing chromosomal breaks. Results should be compared to the isogenic wild-type cells (DT40; aeid 1124 ) and Rev3(-/-) (DT40_657; aeid 2131) to evaluate potential DNA-damaging agents", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "regulation of DNA repair", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 382, + "assayName": "TOX21_DT40", + "assayDesc": "TOX21_DT40 is a cell-based, single-readout assay that uses DT40, a chicken lymphoblast cell line, with measurements taken at 40 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 40.0, + "organismId": 9031, + "organism": "chicken", + "tissue": "lymphoblast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "DT40", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 7782, + "geneName": "RAD54 like (S. cerevisiae)", + "description": null, + "geneSymbol": "RAD54L", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 8438, + "officialSymbol": "RAD54L", + "officialFullName": "RAD54 like (S. cerevisiae)", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 2131, + "assayComponentEndpointName": "TOX21_DT40_657", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_DT40_657 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_DT40_657, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene Rev3. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the DNA repair family.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tetraoctyl ammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "DNA repair", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2013, + "assayComponentName": "TOX21_DT40_657", + "assayComponentDesc": "TOX21_DT40_657 is an assay readout measuring cellular ATP content as a determinant of cell viability using CellTiter-Glo Luciferase-coupled ATP quantitation", + "assayComponentTargetDesc": "TOX21_DT40_657 assay was designed to target cell cycle (cytotoxicity) activity at the cellular (cellular) level, specifically mapping to Rev3 gene(s) using a positive control of tetraoctylammonium bromide. The DT40_657 cells have Rev3 gene deletions (-/-) which is involved in DNA repair. Results should be compared to the isogenic wild-type cells (DT40; aeid 1124 ) and Ku70/Rad54 (DT40_100; aeid 2130) to evaluate potential DNA-damaging agents. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "regulation of DNA repair", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 382, + "assayName": "TOX21_DT40", + "assayDesc": "TOX21_DT40 is a cell-based, single-readout assay that uses DT40, a chicken lymphoblast cell line, with measurements taken at 40 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 40.0, + "organismId": 9031, + "organism": "chicken", + "tissue": "lymphoblast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "DT40", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 5996, + "geneName": "REV3 like, DNA directed polymerase zeta catalytic subunit", + "description": null, + "geneSymbol": "REV3L", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5980, + "officialSymbol": "REV3L", + "officialFullName": "REV3 like, DNA directed polymerase zeta catalytic subunit", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 2143, + "assayComponentEndpointName": "CEETOX_H295R_11DCORT_noMTC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_11DCORT_noMTC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_11DCORT_noMTC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of 11-Deoxycortisol in H295R cell line at 48hr of chemical exposure, without filtering concentrations for maximum tolerated concentration (MTC). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is glucocorticoids.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "prochloraz; forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "11-Deoxycortisol", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "glucocorticoids", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2023, + "assayComponentName": "CEETOX_H295R_11DCORT_noMTC", + "assayComponentDesc": "one of 12 assay component(s) measured or calculated from the CEETOX_H295R assay (11 hormones and 1 viability assay). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology. The concentrations for these components have not been pre-filtered for the maximum tolerated concentration (MTC) based on the MTT assay (_noMTC).", + "assayComponentTargetDesc": "steroid hormone biosynthesis", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "HPLC-MS-MS", + "detectionTechnologyTypeSub": "HPLC-MS-MS", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "pre-stimulation", + "keyAssayReagent": "forskolin", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "11-Deoxycortisol", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 2145, + "assayComponentEndpointName": "CEETOX_H295R_OHPREG_noMTC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_OHPREG_noMTC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_OHPREG_noMTC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of 17alpha-hydroxypregnenolone in H295R cell line at 48hr of chemical exposure, without filtering concentrations for maximum tolerated concentration (MTC). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is progestagens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "prochloraz; forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "17alpha-hydroxypregnenolone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "progestagens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2024, + "assayComponentName": "CEETOX_H295R_OHPREG_noMTC", + "assayComponentDesc": "one of 12 assay component(s) measured or calculated from the CEETOX_H295R assay (11 hormones and 1 viability assay). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology. The concentrations for these components have not been pre-filtered for the maximum tolerated concentration (MTC) based on the MTT assay (_noMTC).", + "assayComponentTargetDesc": "steroid hormone biosynthesis", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "HPLC-MS-MS", + "detectionTechnologyTypeSub": "HPLC-MS-MS", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "pre-stimulation", + "keyAssayReagent": "forskolin", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "17alpha-hydroxypregnenolone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 350, + "geneName": "nuclear receptor subfamily 1, group I, member 2", + "description": null, + "geneSymbol": "NR1I2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8856, + "officialSymbol": "NR1I2", + "officialFullName": "nuclear receptor subfamily 1, group I, member 2", + "uniprotAccessionNumber": "O75469" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 2147, + "assayComponentEndpointName": "CEETOX_H295R_OHPROG_noMTC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_OHPROG_noMTC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_OHPROG_noMTC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of 17alpha-hydroxyprogesterone in H295R cell line at 48hr of chemical exposure, without filtering concentrations for maximum tolerated concentration (MTC). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is progestagens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "prochloraz; forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "17alpha-hydroxyprogesterone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "progestagens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2025, + "assayComponentName": "CEETOX_H295R_OHPROG_noMTC", + "assayComponentDesc": "one of 12 assay component(s) measured or calculated from the CEETOX_H295R assay (11 hormones and 1 viability assay). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology. The concentrations for these components have not been pre-filtered for the maximum tolerated concentration (MTC) based on the MTT assay (_noMTC).", + "assayComponentTargetDesc": "steroid hormone biosynthesis", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "HPLC-MS-MS", + "detectionTechnologyTypeSub": "HPLC-MS-MS", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "pre-stimulation", + "keyAssayReagent": "forskolin", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "17alpha-hydroxyprogesterone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 350, + "geneName": "nuclear receptor subfamily 1, group I, member 2", + "description": null, + "geneSymbol": "NR1I2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8856, + "officialSymbol": "NR1I2", + "officialFullName": "nuclear receptor subfamily 1, group I, member 2", + "uniprotAccessionNumber": "O75469" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 2149, + "assayComponentEndpointName": "CEETOX_H295R_ANDR_noMTC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_ANDR_noMTC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_ANDR_noMTC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Androstenedione in H295R cell line at 48hr of chemical exposure, without filtering concentrations for maximum tolerated concentration (MTC). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is androgens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "prochloraz; forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Androstenedione", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "androgens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2026, + "assayComponentName": "CEETOX_H295R_ANDR_noMTC", + "assayComponentDesc": "one of 12 assay component(s) measured or calculated from the CEETOX_H295R assay (11 hormones and 1 viability assay). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology. The concentrations for these components have not been pre-filtered for the maximum tolerated concentration (MTC) based on the MTT assay (_noMTC).", + "assayComponentTargetDesc": "steroid hormone biosynthesis", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "HPLC-MS-MS", + "detectionTechnologyTypeSub": "HPLC-MS-MS", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "pre-stimulation", + "keyAssayReagent": "forskolin", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Androstenedione", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 1203, + "assayComponentEndpointName": "TOX21_AR_BLA_Antagonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AR_BLA_Antagonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AR_BLA_Antagonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Cyproterone acetate", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 765, + "assayComponentName": "TOX21_AR_BLA_Antagonist_ch2", + "assayComponentDesc": "TOX21_AR_BLA_Antagonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_AR_BLA_Antagonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to AR gene(s) using a positive control of Cyproterone acetate", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 311, + "assayName": "TOX21_AR_BLA_Antagonist", + "assayDesc": "TOX21_AR_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 1204, + "assayComponentEndpointName": "ATG_XTT_Cytotoxicity", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_XTT_Cytotoxicity was analyzed into 1 assay endpoint. This assay endpoint, ATG_XTT_Cytotoxicity, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of viability reporter, loss-of-signal activity can be used to understand changes in the viability. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 766, + "assayComponentName": "ATG_XTT_Cytotoxicity", + "assayComponentDesc": "ATG_XTT_Cytotoxicity is one of one assay component(s) measured or calculated from the ATG_XTT_Cytotoxicity assay. It is designed to make measurements of cell number, a form of viability reporter, as detected with fluorescence intensity signals by XTT cytotoxicity assay technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction involving the key substrate [XTT reagent] are correlated to the viability of the mitochondria in the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell number", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "XTT cytotoxicity assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "XTT reagent", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 386, + "assayName": "ATG_XTT_Cytotoxicity", + "assayDesc": "ATG_XTT_Cytotoxicity is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1315, + "assayComponentEndpointName": "TOX21_p53_BLA_p2_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p2_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p2_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 890, + "assayComponentName": "TOX21_p53_BLA_p2_ch1", + "assayComponentDesc": "TOX21_p53_BLA_p2_ch1 is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_p53_BLA_p2_ch1 was designed to measure uncleaved reporter gene substrate to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 402, + "assayName": "TOX21_p53_BLA_p2", + "assayDesc": "TOX21_p53_BLA_p2 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1316, + "assayComponentEndpointName": "TOX21_p53_BLA_p2_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p2_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p2_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 891, + "assayComponentName": "TOX21_p53_BLA_p2_ch2", + "assayComponentDesc": "TOX21_p53_BLA_p2_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_p53_BLA_p2_ch2 was designed to measure cleaved reporter gene substrate to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 402, + "assayName": "TOX21_p53_BLA_p2", + "assayDesc": "TOX21_p53_BLA_p2 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1317, + "assayComponentEndpointName": "TOX21_p53_BLA_p2_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p2_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p2_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the DNA binding intended target family, where the subfamily is tumor suppressor.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "tumor suppressor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 892, + "assayComponentName": "TOX21_p53_BLA_p2_ratio", + "assayComponentDesc": "TOX21_p53_BLA_p2_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_p53_BLA_p2_ratio was designed to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 402, + "assayName": "TOX21_p53_BLA_p2", + "assayDesc": "TOX21_p53_BLA_p2 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 329, + "geneName": "tumor protein p53", + "description": null, + "geneSymbol": "TP53", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7157, + "officialSymbol": "TP53", + "officialFullName": "tumor protein p53", + "uniprotAccessionNumber": "P04637" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1318, + "assayComponentEndpointName": "TOX21_p53_BLA_p2_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_p53_BLA_p2_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 893, + "assayComponentName": "TOX21_p53_BLA_p2_viability", + "assayComponentDesc": "TOX21_p53_BLA_p2_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 402, + "assayName": "TOX21_p53_BLA_p2", + "assayDesc": "TOX21_p53_BLA_p2 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1319, + "assayComponentEndpointName": "TOX21_p53_BLA_p3_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p3_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p3_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 894, + "assayComponentName": "TOX21_p53_BLA_p3_ch1", + "assayComponentDesc": "TOX21_p53_BLA_p3_ch1 is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_p53_BLA_p3_ch1 was designed to measure uncleaved reporter gene substrate to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 403, + "assayName": "TOX21_p53_BLA_p3", + "assayDesc": "TOX21_p53_BLA_p3 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1320, + "assayComponentEndpointName": "TOX21_p53_BLA_p3_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p3_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p3_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 895, + "assayComponentName": "TOX21_p53_BLA_p3_ch2", + "assayComponentDesc": "TOX21_p53_BLA_p3_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_p53_BLA_p3_ch2 was designed to measure cleaved reporter gene substrate to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 403, + "assayName": "TOX21_p53_BLA_p3", + "assayDesc": "TOX21_p53_BLA_p3 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1321, + "assayComponentEndpointName": "TOX21_p53_BLA_p3_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p3_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p3_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the DNA binding intended target family, where the subfamily is tumor suppressor.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "tumor suppressor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 896, + "assayComponentName": "TOX21_p53_BLA_p3_ratio", + "assayComponentDesc": "TOX21_p53_BLA_p3_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_p53_BLA_p3_ratio was designed to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 403, + "assayName": "TOX21_p53_BLA_p3", + "assayDesc": "TOX21_p53_BLA_p3 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 329, + "geneName": "tumor protein p53", + "description": null, + "geneSymbol": "TP53", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7157, + "officialSymbol": "TP53", + "officialFullName": "tumor protein p53", + "uniprotAccessionNumber": "P04637" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1322, + "assayComponentEndpointName": "TOX21_p53_BLA_p3_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_p53_BLA_p3_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 897, + "assayComponentName": "TOX21_p53_BLA_p3_viability", + "assayComponentDesc": "TOX21_p53_BLA_p3_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 403, + "assayName": "TOX21_p53_BLA_p3", + "assayDesc": "TOX21_p53_BLA_p3 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1323, + "assayComponentEndpointName": "TOX21_p53_BLA_p4_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p4_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p4_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 898, + "assayComponentName": "TOX21_p53_BLA_p4_ch1", + "assayComponentDesc": "TOX21_p53_BLA_p4_ch1 is an assay readout measuring reporter gene via transcripton factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_p53_BLA_p4_ch1 was designed to measure uncleaved reporter gene substrate to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 404, + "assayName": "TOX21_p53_BLA_p4", + "assayDesc": "TOX21_p53_BLA_p4 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1002/em.21934", + "url": "https://pubmed.ncbi.nlm.nih.gov/25537651/", + "pmid": 25537651, + "title": "An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity", + "author": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA", + "citation": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA. An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity. Environ Mol Mutagen. 2015 Jun;56(5):468-76. doi: 10.1002/em.21934. Epub 2014 Dec 23. PMID: 25537651.", + "otherId": "0", + "citationId": 259, + "otherSource": "" + } + }, + { + "aeid": 1324, + "assayComponentEndpointName": "TOX21_p53_BLA_p4_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p4_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p4_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 899, + "assayComponentName": "TOX21_p53_BLA_p4_ch2", + "assayComponentDesc": "TOX21_p53_BLA_p4_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_p53_BLA_p4_ch2 was designed to measure cleaved reporter gene substrate to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 404, + "assayName": "TOX21_p53_BLA_p4", + "assayDesc": "TOX21_p53_BLA_p4 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1002/em.21934", + "url": "https://pubmed.ncbi.nlm.nih.gov/25537651/", + "pmid": 25537651, + "title": "An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity", + "author": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA", + "citation": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA. An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity. Environ Mol Mutagen. 2015 Jun;56(5):468-76. doi: 10.1002/em.21934. Epub 2014 Dec 23. PMID: 25537651.", + "otherId": "0", + "citationId": 259, + "otherSource": "" + } + }, + { + "aeid": 1325, + "assayComponentEndpointName": "TOX21_p53_BLA_p4_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p4_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p4_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the DNA binding intended target family, where the subfamily is tumor suppressor.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "tumor suppressor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 900, + "assayComponentName": "TOX21_p53_BLA_p4_ratio", + "assayComponentDesc": "TOX21_p53_BLA_p4_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1)reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_p53_BLA_p4_ratio was designed to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 404, + "assayName": "TOX21_p53_BLA_p4", + "assayDesc": "TOX21_p53_BLA_p4 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 329, + "geneName": "tumor protein p53", + "description": null, + "geneSymbol": "TP53", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7157, + "officialSymbol": "TP53", + "officialFullName": "tumor protein p53", + "uniprotAccessionNumber": "P04637" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1002/em.21934", + "url": "https://pubmed.ncbi.nlm.nih.gov/25537651/", + "pmid": 25537651, + "title": "An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity", + "author": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA", + "citation": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA. An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity. Environ Mol Mutagen. 2015 Jun;56(5):468-76. doi: 10.1002/em.21934. Epub 2014 Dec 23. PMID: 25537651.", + "otherId": "0", + "citationId": 259, + "otherSource": "" + } + }, + { + "aeid": 1326, + "assayComponentEndpointName": "TOX21_p53_BLA_p4_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_p53_BLA_p4_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 901, + "assayComponentName": "TOX21_p53_BLA_p4_viability", + "assayComponentDesc": "TOX21_p53_BLA_p4_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 404, + "assayName": "TOX21_p53_BLA_p4", + "assayDesc": "TOX21_p53_BLA_p4 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1002/em.21934", + "url": "https://pubmed.ncbi.nlm.nih.gov/25537651/", + "pmid": 25537651, + "title": "An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity", + "author": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA", + "citation": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA. An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity. Environ Mol Mutagen. 2015 Jun;56(5):468-76. doi: 10.1002/em.21934. Epub 2014 Dec 23. PMID: 25537651.", + "otherId": "0", + "citationId": 259, + "otherSource": "" + } + }, + { + "aeid": 1327, + "assayComponentEndpointName": "TOX21_p53_BLA_p5_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p5_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p5_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 902, + "assayComponentName": "TOX21_p53_BLA_p5_ch1", + "assayComponentDesc": "TOX21_p53_BLA_p5_ch1 is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_p53_BLA_p5_ch1 was designed measure uncleaved reporter gene substrate to to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 405, + "assayName": "TOX21_p53_BLA_p5", + "assayDesc": "TOX21_p53_BLA_p5 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1002/em.21934", + "url": "https://pubmed.ncbi.nlm.nih.gov/25537651/", + "pmid": 25537651, + "title": "An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity", + "author": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA", + "citation": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA. An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity. Environ Mol Mutagen. 2015 Jun;56(5):468-76. doi: 10.1002/em.21934. Epub 2014 Dec 23. PMID: 25537651.", + "otherId": "0", + "citationId": 259, + "otherSource": "" + } + }, + { + "aeid": 1328, + "assayComponentEndpointName": "TOX21_p53_BLA_p5_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p5_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p5_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 903, + "assayComponentName": "TOX21_p53_BLA_p5_ch2", + "assayComponentDesc": "TOX21_p53_BLA_p5_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_p53_BLA_p5_ch2 was designed measure cleaved reporter gene substrate to to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 405, + "assayName": "TOX21_p53_BLA_p5", + "assayDesc": "TOX21_p53_BLA_p5 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1002/em.21934", + "url": "https://pubmed.ncbi.nlm.nih.gov/25537651/", + "pmid": 25537651, + "title": "An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity", + "author": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA", + "citation": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA. An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity. Environ Mol Mutagen. 2015 Jun;56(5):468-76. doi: 10.1002/em.21934. Epub 2014 Dec 23. PMID: 25537651.", + "otherId": "0", + "citationId": 259, + "otherSource": "" + } + }, + { + "aeid": 1329, + "assayComponentEndpointName": "TOX21_p53_BLA_p5_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_p53_BLA_p5_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_p53_BLA_p5_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TP53. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the DNA binding intended target family, where the subfamily is tumor suppressor.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mitomycin C;Nutlin3", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "tumor suppressor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 904, + "assayComponentName": "TOX21_p53_BLA_p5_ratio", + "assayComponentDesc": "TOX21_p53_BLA_p5_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_p53_BLA_p5_ratio was designed to target transcription factor activity, specifically mapping to TP53 gene(s) using a positive control of Mitomycin C", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 405, + "assayName": "TOX21_p53_BLA_p5", + "assayDesc": "TOX21_p53_BLA_p5 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 329, + "geneName": "tumor protein p53", + "description": null, + "geneSymbol": "TP53", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7157, + "officialSymbol": "TP53", + "officialFullName": "tumor protein p53", + "uniprotAccessionNumber": "P04637" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1002/em.21934", + "url": "https://pubmed.ncbi.nlm.nih.gov/25537651/", + "pmid": 25537651, + "title": "An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity", + "author": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA", + "citation": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA. An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity. Environ Mol Mutagen. 2015 Jun;56(5):468-76. doi: 10.1002/em.21934. Epub 2014 Dec 23. PMID: 25537651.", + "otherId": "0", + "citationId": 259, + "otherSource": "" + } + }, + { + "aeid": 1330, + "assayComponentEndpointName": "TOX21_p53_BLA_p5_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_p53_BLA_p5_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 905, + "assayComponentName": "TOX21_p53_BLA_p5_viability", + "assayComponentDesc": "TOX21_p53_BLA_p5_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 405, + "assayName": "TOX21_p53_BLA_p5", + "assayDesc": "TOX21_p53_BLA_p5 is a cell-based, single-readout assay that uses HCT116, a human intestinal cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HCT116", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1002/em.21934", + "url": "https://pubmed.ncbi.nlm.nih.gov/25537651/", + "pmid": 25537651, + "title": "An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity", + "author": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA", + "citation": "Kligerman AD, Young RR, Stankowski LF Jr, Pant K, Lawlor T, Aardema MJ, Houck KA. An evaluation of 25 selected ToxCast chemicals in medium-throughput assays to detect genotoxicity. Environ Mol Mutagen. 2015 Jun;56(5):468-76. doi: 10.1002/em.21934. Epub 2014 Dec 23. PMID: 25537651.", + "otherId": "0", + "citationId": 259, + "otherSource": "" + } + }, + { + "aeid": 1331, + "assayComponentEndpointName": "TOX21_VDR_BLA_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_VDR_BLA_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 906, + "assayComponentName": "TOX21_VDR_BLA_Agonist_viability", + "assayComponentDesc": "TOX21_VDR_BLA_Agonist_viability is one of 2 assay component(s) measured or calculated from the TOX21_VDR_BLA_Agonist assay. It is designed to make measurements of ATP content, a form of viability reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 380, + "assayName": "TOX21_VDR_BLA_Agonist", + "assayDesc": "TOX21_VDR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1038/s41598-018-27055-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/29891985/", + "pmid": 29891985, + "title": "Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays", + "author": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW", + "citation": "Mahapatra D, Franzosa JA, Roell K, Kuenemann MA, Houck KA, Reif DM, Fourches D, Kullman SW. Confirmation of high-throughput screening data and novel mechanistic insights into VDR-xenobiotic interactions by orthogonal assays. Sci Rep. 2018 Jun 11;8(1):8883. doi: 10.1038/s41598-018-27055-3. PMID: 29891985; PMCID: PMC5995905.", + "otherId": "0", + "citationId": 270, + "otherSource": "" + } + }, + { + "aeid": 1340, + "assayComponentEndpointName": "TOX21_ESRE_BLA_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ESRE_BLA_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ESRE_BLA_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ATF6. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17-AAG", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 907, + "assayComponentName": "TOX21_ESRE_BLA_ch1", + "assayComponentDesc": "TOX21_ESRE_BLA_ch1 is an assay readout measuring transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ESRE_BLA_ch1 was designed to measure uncleaved reporter gene substrate to target transcription factor activity, specifically mapping to ATF6 gene(s) using a positive control of 17-AAG", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 406, + "assayName": "TOX21_ESRE_BLA", + "assayDesc": "TOX21_ESRE_BLA is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1341, + "assayComponentEndpointName": "TOX21_ESRE_BLA_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ESRE_BLA_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ESRE_BLA_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ATF6. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17-AAG", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 908, + "assayComponentName": "TOX21_ESRE_BLA_ch2", + "assayComponentDesc": "TOX21_ESRE_BLA_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ESRE_BLA_ch2 was designed to measure cleaved reporter gene substrate to target transcription factor activity, specifically mapping to ATF6 gene(s) using a positive control of 17-AAG", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 406, + "assayName": "TOX21_ESRE_BLA", + "assayDesc": "TOX21_ESRE_BLA is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1342, + "assayComponentEndpointName": "TOX21_ESRE_BLA_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ESRE_BLA_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ESRE_BLA_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of receptor for gain-of-signal activity can be used to understand the reporter gene at the pathway-level as they relate to the gene ATF6. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the DNA binding intended target family, where the subfamily is basic leucine zipper.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17-AAG", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 909, + "assayComponentName": "TOX21_ESRE_BLA_ratio", + "assayComponentDesc": "TOX21_ESRE_BLA_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_ESRE_BLA_ratio was designed to target transcription factor activity, specifically mapping to ATF6 gene(s) using a positive control of 17-AAG", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 406, + "assayName": "TOX21_ESRE_BLA", + "assayDesc": "TOX21_ESRE_BLA is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 373, + "geneName": "activating transcription factor 6", + "description": null, + "geneSymbol": "ATF6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 22926, + "officialSymbol": "ATF6", + "officialFullName": "activating transcription factor 6", + "uniprotAccessionNumber": "P18850" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1343, + "assayComponentEndpointName": "TOX21_ESRE_BLA_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_ESRE_BLA_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 910, + "assayComponentName": "TOX21_ESRE_BLA_viability", + "assayComponentDesc": "TOX21_ESRE_BLA_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 406, + "assayName": "TOX21_ESRE_BLA", + "assayDesc": "TOX21_ESRE_BLA is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 1344, + "assayComponentEndpointName": "TOX21_NFkB_BLA_agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_NFkB_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_NFkB_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NFKB1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TNFa", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 911, + "assayComponentName": "TOX21_NFkB_BLA_agonist_ch1", + "assayComponentDesc": "TOX21_NFkB_BLA_Agonist_ch1 is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_NFkB_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target transcription factor activity, specifically mapping to NFKB1 gene(s) using a positive control of TNFa", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 407, + "assayName": "TOX21_NFkB_BLA_Agonist", + "assayDesc": "TOX21_NFkB_BLA_Agonist is a cell-based, single-readout assay that uses ME-180, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ME-180", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1345, + "assayComponentEndpointName": "TOX21_NFkB_BLA_agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_NFkB_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_NFkB_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene NFKB1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TNFa", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 912, + "assayComponentName": "TOX21_NFkB_BLA_agonist_ch2", + "assayComponentDesc": "TOX21_NFkB_BLA_Agonist_ch2 is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_NFkB_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target transcription factor activity, specifically mapping to NFKB1 gene(s) using a positive control of TNFa", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 407, + "assayName": "TOX21_NFkB_BLA_Agonist", + "assayDesc": "TOX21_NFkB_BLA_Agonist is a cell-based, single-readout assay that uses ME-180, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ME-180", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1346, + "assayComponentEndpointName": "TOX21_NFkB_BLA_agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_NFkB_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_NFkB_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NFKB1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the DNA binding intended target family, where the subfamily is NF-kappa B.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TNFa", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "NF-kappa B", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 913, + "assayComponentName": "TOX21_NFkB_BLA_agonist_ratio", + "assayComponentDesc": "TOX21_NFkB_BLA_Agonist_ratio is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_NFkB_BLA_Agonist_ratio was designed to target transcription factor activity, specifically mapping to NFKB1 gene(s) using a positive control of TNFa", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 407, + "assayName": "TOX21_NFkB_BLA_Agonist", + "assayDesc": "TOX21_NFkB_BLA_Agonist is a cell-based, single-readout assay that uses ME-180, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ME-180", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 218, + "geneName": "nuclear factor of kappa light polypeptide gene enhancer in B-cells 1", + "description": null, + "geneSymbol": "NFKB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4790, + "officialSymbol": "NFKB1", + "officialFullName": "nuclear factor of kappa light polypeptide gene enhancer in B-cells 1", + "uniprotAccessionNumber": "P19838" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1347, + "assayComponentEndpointName": "TOX21_NFkB_BLA_agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_NFkB_BLA_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 914, + "assayComponentName": "TOX21_NFkB_BLA_agonist_viability", + "assayComponentDesc": "TOX21_NFkB_BLA_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 407, + "assayName": "TOX21_NFkB_BLA_Agonist", + "assayDesc": "TOX21_NFkB_BLA_Agonist is a cell-based, single-readout assay that uses ME-180, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ME-180", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 1348, + "assayComponentEndpointName": "ATG_NUR77_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint, ATG_NUR77_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR4A1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 915, + "assayComponentName": "ATG_NUR77_TRANS2", + "assayComponentDesc": "ATG_NUR77_TRANS2 is one of 24 assay components measured from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-NURR77 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 155, + "geneName": "nuclear receptor subfamily 4, group A, member 1", + "description": null, + "geneSymbol": "NR4A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3164, + "officialSymbol": "NR4A1", + "officialFullName": "nuclear receptor subfamily 4, group A, member 1", + "uniprotAccessionNumber": "P22736" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1349, + "assayComponentEndpointName": "ATG_GCNF_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GCNF_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR6A1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 916, + "assayComponentName": "ATG_GCNF_TRANS2", + "assayComponentDesc": "ATG_GCNF_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-GCNF RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 140, + "geneName": "nuclear receptor subfamily 6, group A, member 1", + "description": null, + "geneSymbol": "NR6A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2649, + "officialSymbol": "NR6A1", + "officialFullName": "nuclear receptor subfamily 6, group A, member 1", + "uniprotAccessionNumber": "Q15406" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1350, + "assayComponentEndpointName": "ATG_COUP_TF2_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_COUP_TF2_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR2F2. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 917, + "assayComponentName": "ATG_COUP_TF2_TRANS2", + "assayComponentDesc": "ATG_COUP_TF2_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-TF2 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 317, + "geneName": "nuclear receptor subfamily 2, group F, member 2", + "description": null, + "geneSymbol": "NR2F2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7026, + "officialSymbol": "NR2F2", + "officialFullName": "nuclear receptor subfamily 2, group F, member 2", + "uniprotAccessionNumber": "P24468" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1351, + "assayComponentEndpointName": "ATG_PNR_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_PNR_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR2E3. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 918, + "assayComponentName": "ATG_PNR_TRANS2", + "assayComponentDesc": "ATG_PNR_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-PNR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 360, + "geneName": "nuclear receptor subfamily 2, group E, member 3", + "description": null, + "geneSymbol": "NR2E3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10002, + "officialSymbol": "NR2E3", + "officialFullName": "nuclear receptor subfamily 2, group E, member 3", + "uniprotAccessionNumber": "Q9Y5X4" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1352, + "assayComponentEndpointName": "ATG_LRH1_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_LRH1_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR5A2. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 919, + "assayComponentName": "ATG_LRH1_TRANS2", + "assayComponentDesc": "ATG_LRH1_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-LRH1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 135, + "geneName": "nuclear receptor subfamily 5, group A, member 2", + "description": null, + "geneSymbol": "NR5A2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2494, + "officialSymbol": "NR5A2", + "officialFullName": "nuclear receptor subfamily 5, group A, member 2", + "uniprotAccessionNumber": "O00482" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1353, + "assayComponentEndpointName": "ATG_Rev_ERB_A_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_Rev_ERB_A_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR1D1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 920, + "assayComponentName": "ATG_Rev_ERB_A_TRANS2", + "assayComponentDesc": "ATG_Rev_ERB_A_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-erb-a RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 355, + "geneName": "nuclear receptor subfamily 1, group D, member 1", + "description": null, + "geneSymbol": "NR1D1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9572, + "officialSymbol": "NR1D1", + "officialFullName": "nuclear receptor subfamily 1, group D, member 1", + "uniprotAccessionNumber": "P20393" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1354, + "assayComponentEndpointName": "ATG_HNF4g_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_HNF4g_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene HNF4G. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 921, + "assayComponentName": "ATG_HNF4g_TRANS2", + "assayComponentDesc": "ATG_HNF4g_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-HNF4-g RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 158, + "geneName": "hepatocyte nuclear factor 4, gamma", + "description": null, + "geneSymbol": "HNF4G", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3174, + "officialSymbol": "HNF4G", + "officialFullName": "hepatocyte nuclear factor 4, gamma", + "uniprotAccessionNumber": "Q14541" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1355, + "assayComponentEndpointName": "ATG_ERRb_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_ERRb_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ESRRB. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 922, + "assayComponentName": "ATG_ERRb_TRANS2", + "assayComponentDesc": "ATG_ERRb_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-ERR-b RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 120, + "geneName": "estrogen-related receptor beta", + "description": null, + "geneSymbol": "ESRRB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2103, + "officialSymbol": "ESRRB", + "officialFullName": "estrogen-related receptor beta", + "uniprotAccessionNumber": "O95718" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1356, + "assayComponentEndpointName": "ATG_MR_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_MR_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR3C2. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 923, + "assayComponentName": "ATG_MR_TRANS2", + "assayComponentDesc": "ATG_MR_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-MR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 202, + "geneName": "nuclear receptor subfamily 3, group C, member 2", + "description": null, + "geneSymbol": "NR3C2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4306, + "officialSymbol": "NR3C2", + "officialFullName": "nuclear receptor subfamily 3, group C, member 2", + "uniprotAccessionNumber": "P08235" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 2151, + "assayComponentEndpointName": "CEETOX_H295R_CORTIC_noMTC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_CORTIC_noMTC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_CORTIC_noMTC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Corticosterone in H295R cell line at 48hr of chemical exposure, without filtering concentrations for maximum tolerated concentration (MTC). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is glucocorticoids.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "prochloraz; forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Corticosterone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "glucocorticoids", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2027, + "assayComponentName": "CEETOX_H295R_CORTIC_noMTC", + "assayComponentDesc": "one of 12 assay component(s) measured or calculated from the CEETOX_H295R assay (11 hormones and 1 viability assay). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology. The concentrations for these components have not been pre-filtered for the maximum tolerated concentration (MTC) based on the MTT assay (_noMTC).", + "assayComponentTargetDesc": "steroid hormone biosynthesis", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "HPLC-MS-MS", + "detectionTechnologyTypeSub": "HPLC-MS-MS", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "pre-stimulation", + "keyAssayReagent": "forskolin", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Corticosterone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 2153, + "assayComponentEndpointName": "CEETOX_H295R_CORTISOL_noMTC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_CORTISOL_noMTC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_CORTISOL_noMTC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Cortisol in H295R cell line at 48hr of chemical exposure, without filtering concentrations for maximum tolerated concentration (MTC). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is glucocorticoids.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "prochloraz; forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Cortisol ", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "glucocorticoids", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2028, + "assayComponentName": "CEETOX_H295R_CORTISOL_noMTC", + "assayComponentDesc": "one of 12 assay component(s) measured or calculated from the CEETOX_H295R assay (11 hormones and 1 viability assay). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology. The concentrations for these components have not been pre-filtered for the maximum tolerated concentration (MTC) based on the MTT assay (_noMTC).", + "assayComponentTargetDesc": "steroid hormone biosynthesis", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "HPLC-MS-MS", + "detectionTechnologyTypeSub": "HPLC-MS-MS", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "pre-stimulation", + "keyAssayReagent": "forskolin", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Cortisol ", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 2157, + "assayComponentEndpointName": "CEETOX_H295R_DOC_noMTC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_DOC_noMTC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_DOC_noMTC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of 11-Deoxycorticosterone in H295R cell line at 48hr of chemical exposure, without filtering concentrations for maximum tolerated concentration (MTC). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is glucocorticoids.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "prochloraz; forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "11-Deoxycorticosterone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "glucocorticoids", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2030, + "assayComponentName": "CEETOX_H295R_DOC_noMTC", + "assayComponentDesc": "one of 12 assay component(s) measured or calculated from the CEETOX_H295R assay (11 hormones and 1 viability assay). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology. The concentrations for these components have not been pre-filtered for the maximum tolerated concentration (MTC) based on the MTT assay (_noMTC).", + "assayComponentTargetDesc": "steroid hormone biosynthesis", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "HPLC-MS-MS", + "detectionTechnologyTypeSub": "HPLC-MS-MS", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "pre-stimulation", + "keyAssayReagent": "forskolin", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "11-Deoxycorticosterone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 2159, + "assayComponentEndpointName": "CEETOX_H295R_ESTRADIOL_noMTC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_ESTRADIOL_noMTC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_ESTRADIOL_noMTC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Estradiol in H295R cell line at 48hr of chemical exposure, without filtering concentrations for maximum tolerated concentration (MTC). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is estrogens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "prochloraz; forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Estradiol", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "estrogens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2031, + "assayComponentName": "CEETOX_H295R_ESTRADIOL_noMTC", + "assayComponentDesc": "one of 12 assay component(s) measured or calculated from the CEETOX_H295R assay (11 hormones and 1 viability assay). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology. The concentrations for these components have not been pre-filtered for the maximum tolerated concentration (MTC) based on the MTT assay (_noMTC).", + "assayComponentTargetDesc": "steroid hormone biosynthesis", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "HPLC-MS-MS", + "detectionTechnologyTypeSub": "HPLC-MS-MS", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "pre-stimulation", + "keyAssayReagent": "forskolin", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Estradiol", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 2161, + "assayComponentEndpointName": "CEETOX_H295R_ESTRONE_noMTC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_ESTRONE_noMTC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_ESTRONE_noMTC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Estrone in H295R cell line at 48hr of chemical exposure, without filtering concentrations for maximum tolerated concentration (MTC). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is estrogens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "prochloraz; forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Estrone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "estrogens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2032, + "assayComponentName": "CEETOX_H295R_ESTRONE_noMTC", + "assayComponentDesc": "one of 12 assay component(s) measured or calculated from the CEETOX_H295R assay (11 hormones and 1 viability assay). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology. The concentrations for these components have not been pre-filtered for the maximum tolerated concentration (MTC) based on the MTT assay (_noMTC).", + "assayComponentTargetDesc": "steroid hormone biosynthesis", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "HPLC-MS-MS", + "detectionTechnologyTypeSub": "HPLC-MS-MS", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "pre-stimulation", + "keyAssayReagent": "forskolin", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Estrone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 2165, + "assayComponentEndpointName": "CEETOX_H295R_PROG_noMTC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_PROG_noMTC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_PROG_noMTC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Progesterone in H295R cell line at 48hr of chemical exposure, without filtering concentrations for maximum tolerated concentration (MTC). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is progestagens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "prochloraz; forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Progesterone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "progestagens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2034, + "assayComponentName": "CEETOX_H295R_PROG_noMTC", + "assayComponentDesc": "one of 12 assay component(s) measured or calculated from the CEETOX_H295R assay (11 hormones and 1 viability assay). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology. The concentrations for these components have not been pre-filtered for the maximum tolerated concentration (MTC) based on the MTT assay (_noMTC).", + "assayComponentTargetDesc": "steroid hormone biosynthesis", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "HPLC-MS-MS", + "detectionTechnologyTypeSub": "HPLC-MS-MS", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "pre-stimulation", + "keyAssayReagent": "forskolin", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Progesterone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 2167, + "assayComponentEndpointName": "CEETOX_H295R_TESTO_noMTC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_TESTO_noMTC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_TESTO_noMTC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Testosterone in H295R cell line at 48hr of chemical exposure, without filtering concentrations for maximum tolerated concentration (MTC). To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is androgens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "prochloraz; forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Testosterone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "androgens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2035, + "assayComponentName": "CEETOX_H295R_TESTO_noMTC", + "assayComponentDesc": "one of 12 assay component(s) measured or calculated from the CEETOX_H295R assay (11 hormones and 1 viability assay). It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology. The concentrations for these components have not been pre-filtered for the maximum tolerated concentration (MTC) based on the MTT assay (_noMTC).", + "assayComponentTargetDesc": "steroid hormone biosynthesis", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "HPLC-MS-MS", + "detectionTechnologyTypeSub": "HPLC-MS-MS", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "pre-stimulation", + "keyAssayReagent": "forskolin", + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Testosterone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 2211, + "assayComponentEndpointName": "TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERa_LUC_VM7_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERa_LUC_VM7_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR1. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2073, + "assayComponentName": "TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780", + "assayComponentDesc": "TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780 is one of one assay component(s) measured or calculated from the TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780 assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780 was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] in the presence of an ER antagonist. Changes are indicative of transcriptional gene expression that may not be due to direct regulation by the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "artifact detection", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 640, + "assayName": "TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780", + "assayDesc": "TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780 is a cell-based, single-readout assay that uses VM7, a human breast tissue cell line, with measurements taken at 22 hours after chemical dosing in a 1536-well plate. This is a secondary assay for specificity to TOX21_ERa_LUC_VM7_Agonist.", + "timepointHr": 22.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfv168", + "url": "https://pubmed.ncbi.nlm.nih.gov/26272952/", + "pmid": 26272952, + "title": "Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor", + "author": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS", + "citation": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS. Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor. Toxicol Sci. 2015 Nov;148(1):137-54. doi: 10.1093/toxsci/kfv168. Epub 2015 Aug 13. PMID: 26272952; PMCID: PMC4635633.", + "otherId": "0", + "citationId": 277, + "otherSource": "" + } + }, + { + "aeid": 2212, + "assayComponentEndpointName": "TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2074, + "assayComponentName": "TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780_viability", + "assayComponentDesc": "TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 640, + "assayName": "TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780", + "assayDesc": "TOX21_ERa_LUC_VM7_Agonist_10nM_ICI182780 is a cell-based, single-readout assay that uses VM7, a human breast tissue cell line, with measurements taken at 22 hours after chemical dosing in a 1536-well plate. This is a secondary assay for specificity to TOX21_ERa_LUC_VM7_Agonist.", + "timepointHr": 22.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfv168", + "url": "https://pubmed.ncbi.nlm.nih.gov/26272952/", + "pmid": 26272952, + "title": "Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor", + "author": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS", + "citation": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS. Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor. Toxicol Sci. 2015 Nov;148(1):137-54. doi: 10.1093/toxsci/kfv168. Epub 2015 Aug 13. PMID: 26272952; PMCID: PMC4635633.", + "otherId": "0", + "citationId": 277, + "otherSource": "" + } + }, + { + "aeid": 2213, + "assayComponentEndpointName": "TOX21_RT_HEPG2_GLO_24hr_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RT_HEPG2_GLO_24hr_ctrl_viability used a dead cell DNA stain where an increase in measured fluorescence indicated a loss of cell viability. The assay component endpoint is part of a kinetic analysis of cell death with additional exposure times measured in other assay components as well as live cells measured with a vital dye, e.g. TOX21_RT_HEK293_FLO_08hr_viability", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2075, + "assayComponentName": "TOX21_RT_HEPG2_GLO_24hr_viability", + "assayComponentDesc": "TOX21_RT_HEPG2_GLO_24hr_viability is one of one assay component(s) measured or calculated from the TOX21_RT_HEPG2_GLO_00hr_viability assay. It is designed to make measurements of viable cells as detected with bioluminescence signal generated by NanoLuc luciferase catalysis of a profurimazine substrate which require intracellular reduction of the substrate in a viable cell. ", + "assayComponentTargetDesc": "TOX21_RT_HEPG2_GLO_24hr_viability was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Profurimazine]. Changes are indicative of changes in the number of viable cells which are required for reduction of Profurimazine to a form that can be used by NanoLuc luciferase added as a detection reagent. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "metabolic activity", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "RealTime-Glo MT Cell Viability Assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "NanoLuc/profurimazine", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 587, + "assayName": "TOX21_RT_HEPG2", + "assayDesc": "TOX21_RT_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2214, + "assayComponentEndpointName": "TOX21_PR_BLA_Followup_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_BLA_Followup_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_BLA_Followup_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "promegestone (R5020)", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2275, + "assayComponentName": "TOX21_PR_BLA_Followup_Agonist_ch1", + "assayComponentDesc": "TOX21_PR_BLA_Followup_Agonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Progesterone receptor (PR), a nuclear hormone receptor, plays an important role in development, metabolic homeostasis and reproduction. It is activated by the steroid hormone progesterone. Endocrine disrupting chemicals (EDCs) and their interactions with steroid hormone receptors like PR causes disruption of normal endocrine function. ", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 642, + "assayName": "TOX21_PR_BLA_Followup", + "assayDesc": "TOX21_PR_BLA_Followup is a secondary assay for specificity for the TOX21_PR_BLA_Agonist assay. To differentiate true PR agonists from cytotoxic substances, this follow up assay is multiplexed with a cell viability assay. The compounds were also tested for auto fluorescence that may interfere with the biological target readout resulting in potential false positives and/or negatives. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2215, + "assayComponentEndpointName": "TOX21_PR_BLA_Followup_Antagonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_BLA_Followup_Antagonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_BLA_Followup_Antagonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "RU486", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2276, + "assayComponentName": "TOX21_PR_BLA_Followup_Antagonist_ch1", + "assayComponentDesc": "TOX21_PR_BLA_Followup_Antagonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Progesterone receptor (PR), a nuclear hormone receptor, plays an important role in development, metabolic homeostasis and reproduction. It is activated by the steroid hormone progesterone. Endocrine disrupting chemicals (EDCs) and their interactions with steroid hormone receptors like PR causes disruption of normal endocrine function. ", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 642, + "assayName": "TOX21_PR_BLA_Followup", + "assayDesc": "TOX21_PR_BLA_Followup is a secondary assay for specificity for the TOX21_PR_BLA_Agonist assay. To differentiate true PR agonists from cytotoxic substances, this follow up assay is multiplexed with a cell viability assay. The compounds were also tested for auto fluorescence that may interfere with the biological target readout resulting in potential false positives and/or negatives. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2216, + "assayComponentEndpointName": "TOX21_PR_BLA_Followup_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_BLA_Followup_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_BLA_Followup_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "promegestone (R5020)", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2277, + "assayComponentName": "TOX21_PR_BLA_Followup_Agonist_ch2", + "assayComponentDesc": "TOX21_PR_BLA_Followup_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Progesterone receptor (PR), a nuclear hormone receptor, plays an important role in development, metabolic homeostasis and reproduction. It is activated by the steroid hormone progesterone. Endocrine disrupting chemicals (EDCs) and their interactions with steroid hormone receptors like PR causes disruption of normal endocrine function. ", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 642, + "assayName": "TOX21_PR_BLA_Followup", + "assayDesc": "TOX21_PR_BLA_Followup is a secondary assay for specificity for the TOX21_PR_BLA_Agonist assay. To differentiate true PR agonists from cytotoxic substances, this follow up assay is multiplexed with a cell viability assay. The compounds were also tested for auto fluorescence that may interfere with the biological target readout resulting in potential false positives and/or negatives. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2217, + "assayComponentEndpointName": "TOX21_PR_BLA_Followup_Antagonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_BLA_Followup_Antagonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_BLA_Followup_Antagonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "RU486", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2278, + "assayComponentName": "TOX21_PR_BLA_Followup_Antagonist_ch2", + "assayComponentDesc": "TOX21_PR_BLA_Followup_Antagonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Progesterone receptor (PR), a nuclear hormone receptor, plays an important role in development, metabolic homeostasis and reproduction. It is activated by the steroid hormone progesterone. Endocrine disrupting chemicals (EDCs) and their interactions with steroid hormone receptors like PR causes disruption of normal endocrine function. ", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 642, + "assayName": "TOX21_PR_BLA_Followup", + "assayDesc": "TOX21_PR_BLA_Followup is a secondary assay for specificity for the TOX21_PR_BLA_Agonist assay. To differentiate true PR agonists from cytotoxic substances, this follow up assay is multiplexed with a cell viability assay. The compounds were also tested for auto fluorescence that may interfere with the biological target readout resulting in potential false positives and/or negatives. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2218, + "assayComponentEndpointName": "TOX21_PR_BLA_Followup_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_BLA_Followup_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_BLA_Followup_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of receptor for gain-of-signal activity can be used to understand the reporter gene at the pathway-level as they relate to the gene NR3C3. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "promegestone (R5020)", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2279, + "assayComponentName": "TOX21_PR_BLA_Followup_Agonist_ratio", + "assayComponentDesc": "TOX21_PR_BLA_Followup_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "Progesterone receptor (PR), a nuclear hormone receptor, plays an important role in development, metabolic homeostasis and reproduction. It is activated by the steroid hormone progesterone. Endocrine disrupting chemicals (EDCs) and their interactions with steroid hormone receptors like PR causes disruption of normal endocrine function. ", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 642, + "assayName": "TOX21_PR_BLA_Followup", + "assayDesc": "TOX21_PR_BLA_Followup is a secondary assay for specificity for the TOX21_PR_BLA_Agonist assay. To differentiate true PR agonists from cytotoxic substances, this follow up assay is multiplexed with a cell viability assay. The compounds were also tested for auto fluorescence that may interfere with the biological target readout resulting in potential false positives and/or negatives. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2219, + "assayComponentEndpointName": "TOX21_PR_BLA_Followup_Antagonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_BLA_Followup_Antagonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_BLA_Followup_Antagonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of receptor for gain-of-signal activity can be used to understand the reporter gene at the pathway-level as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "RU486", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2280, + "assayComponentName": "TOX21_PR_BLA_Followup_Antagonist_ratio", + "assayComponentDesc": "TOX21_PR_BLA_Followup_Antagonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "Progesterone receptor (PR), a nuclear hormone receptor, plays an important role in development, metabolic homeostasis and reproduction. It is activated by the steroid hormone progesterone. Endocrine disrupting chemicals (EDCs) and their interactions with steroid hormone receptors like PR causes disruption of normal endocrine function. ", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 642, + "assayName": "TOX21_PR_BLA_Followup", + "assayDesc": "TOX21_PR_BLA_Followup is a secondary assay for specificity for the TOX21_PR_BLA_Agonist assay. To differentiate true PR agonists from cytotoxic substances, this follow up assay is multiplexed with a cell viability assay. The compounds were also tested for auto fluorescence that may interfere with the biological target readout resulting in potential false positives and/or negatives. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2220, + "assayComponentEndpointName": "TOX21_PR_BLA_Followup_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_PR_BLA_Followup_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2281, + "assayComponentName": "TOX21_PR_BLA_Followup_Agonist_viability", + "assayComponentDesc": "TOX21_PR_BLA_Followup_Agonist_viability is a component of the TOX21_PR_BLA_Followup_Agonist assay. This component measures cell viability using the CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 642, + "assayName": "TOX21_PR_BLA_Followup", + "assayDesc": "TOX21_PR_BLA_Followup is a secondary assay for specificity for the TOX21_PR_BLA_Agonist assay. To differentiate true PR agonists from cytotoxic substances, this follow up assay is multiplexed with a cell viability assay. The compounds were also tested for auto fluorescence that may interfere with the biological target readout resulting in potential false positives and/or negatives. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2221, + "assayComponentEndpointName": "TOX21_PR_BLA_Followup_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_PR_BLA_Followup_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2282, + "assayComponentName": "TOX21_PR_BLA_Followup_Antagonist_viability", + "assayComponentDesc": "TOX21_PR_BLA_Followup_Antagonist_viability is a component of the TOX21_PR_BLA_Followup_Antagonist assay. This component measures cell viability using the CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 642, + "assayName": "TOX21_PR_BLA_Followup", + "assayDesc": "TOX21_PR_BLA_Followup is a secondary assay for specificity for the TOX21_PR_BLA_Agonist assay. To differentiate true PR agonists from cytotoxic substances, this follow up assay is multiplexed with a cell viability assay. The compounds were also tested for auto fluorescence that may interfere with the biological target readout resulting in potential false positives and/or negatives. To identify the compounds that stimulate PR signaling, a PR-UAS-bla GripTite cell line i.e. PR-UAS-bla HEK293T (Invitrogen, Carlsbad, CA, USA) containing a beta-lactamase reporter gene under the control of an UAS response element was used to screen Tox21 10K compound library. The cytotoxicity of the Tox21 compound library against the PR-bla cell line was tested in parallel by measuring the cell viability using CellTiter-Glo assay in the same wells. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "PR-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2222, + "assayComponentEndpointName": "TOX21_PR_LUC_Followup_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_LUC_Followup_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_LUC_Followup_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor target family, where the subfamily is steroidal.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "promegestone (R5020)", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2283, + "assayComponentName": "TOX21_PR_LUC_Followup_Agonist", + "assayComponentDesc": "TOX21_PR_LUC_Followup_Agonist is one of one assay component(s) measured or calculated from the TOX21_PR_LUC_Followup assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology", + "assayComponentTargetDesc": "TOX21_PR_LUC_Agonist assay was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human Progesterone receptor (PR)", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 643, + "assayName": "TOX21_PR_LUC_Followup", + "assayDesc": "TOX21_PR_LUC_Followup is a secondary assay for specificity for the TOX21_PR_BLA_Agonist assay. To differentiate true PR agonists from cytotoxic substances, this follow up assay is multiplexed with a cell viability assay.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293-PR-A", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2223, + "assayComponentEndpointName": "TOX21_PR_LUC_Followup_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PR_LUC_Followup_Antagonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PR_LUC_Followup_Antagonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR3C3. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor target family, where the subfamily is steroidal.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "RU486", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2284, + "assayComponentName": "TOX21_PR_LUC_Followup_Antagonist", + "assayComponentDesc": "TOX21_PR_LUC_Followup_Antagonist is one of one assay component(s) measured or calculated from the TOX21_PR_LUC_Followup assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology", + "assayComponentTargetDesc": "TOX21_PR_LUC_Antagonist assay was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to antagonist activity regulated by the human Progesterone receptor (PR)", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 643, + "assayName": "TOX21_PR_LUC_Followup", + "assayDesc": "TOX21_PR_LUC_Followup is a secondary assay for specificity for the TOX21_PR_BLA_Agonist assay. To differentiate true PR agonists from cytotoxic substances, this follow up assay is multiplexed with a cell viability assay.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293-PR-A", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2224, + "assayComponentEndpointName": "TOX21_PR_LUC_Followup_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_PR_LUC_Followup_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2285, + "assayComponentName": "TOX21_PR_LUC_Followup_Agonist_viability", + "assayComponentDesc": "TOX21_PR_LUC_Followup_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 643, + "assayName": "TOX21_PR_LUC_Followup", + "assayDesc": "TOX21_PR_LUC_Followup is a secondary assay for specificity for the TOX21_PR_BLA_Agonist assay. To differentiate true PR agonists from cytotoxic substances, this follow up assay is multiplexed with a cell viability assay.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293-PR-A", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2225, + "assayComponentEndpointName": "TOX21_PR_LUC_Followup_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_PR_LUC_Followup_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2286, + "assayComponentName": "TOX21_PR_LUC_Followup_Antagonist_viability", + "assayComponentDesc": "TOX21_PR_LUC_Followup_Antagonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 643, + "assayName": "TOX21_PR_LUC_Followup", + "assayDesc": "TOX21_PR_LUC_Followup is a secondary assay for specificity for the TOX21_PR_BLA_Agonist assay. To differentiate true PR agonists from cytotoxic substances, this follow up assay is multiplexed with a cell viability assay.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293-PR-A", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2226, + "assayComponentEndpointName": "TOX21_TR_LUC_GH3_Agonist_Followup", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TR_LUC_GH3_Agonist_Followup was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TR_LUC_GH3_Agonist_Followup, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRA and THRB in the GH3 cell line using a luciferase reporter. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. This assay endpoint is designated followup because it was a confirmatory screen following the primary qHTS assay.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2287, + "assayComponentName": "TOX21_TR_LUC_GH3_Agonist_Followup", + "assayComponentDesc": "TOX21_TR_LUC_GH3_Agonist_Followup is one of one assay component(s) measured or calculated from the TOX21_TR_LUC_GH3_Agonist_Followup assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human thyroid hormone receptor, alpha and thyroid hormone receptor, beta [GeneSymbol:THRA & THRB | GeneID:7067 & 7068 | Uniprot_SwissProt_Accession:P10827 & P10828]. Thyroid receptor (TR), a nuclear hormone receptor, plays an important role in development, proliferation, differentiation, metabolism, brain function, and cardiovascular system. TR-interacting compounds have been shown to disrupt thyroid homeostasis.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 644, + "assayName": "TOX21_TR_LUC_GH3_Agonist_Followup", + "assayDesc": "TOX21_TR_LUC_GH3_Agonist_Followup is a secondary assay for specificity for the TOX21_TR_LUC_GH3_Agonist assay. TOX21_TR_LUC_GH3_Agonist_Followup is a cell-based, single-readout assay that uses GH3, a rat pituitary gland cell line, with measurements taken at 28 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 28.0, + "organismId": 10116, + "organism": "rat", + "tissue": "pituitary gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "GH3", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 321, + "geneName": "thyroid hormone receptor, alpha", + "description": null, + "geneSymbol": "THRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7067, + "officialSymbol": "THRA", + "officialFullName": "thyroid hormone receptor, alpha", + "uniprotAccessionNumber": "P10827" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2227, + "assayComponentEndpointName": "TOX21_TR_LUC_GH3_Antagonist_Followup", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TR_LUC_GH3_Antagonist_Followup was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TR_LUC_GH3_Antagonist_Followup, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRA and THRB in the GH3 cell line using a luciferase reporter. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. This assay endpoint is designated followup because it was a confirmatory screen following the primary qHTS assay.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2288, + "assayComponentName": "TOX21_TR_LUC_GH3_Antagonist_Followup", + "assayComponentDesc": "TOX21_TR_LUC_GH3_Antagonist_Followup is one of one assay component(s) measured or calculated from the TOX21_TR_LUC_GH3_Antagonist_Followup assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] are indicative of changes in transcriptional gene expression due to antagonist activity regulated by the human thyroid hormone receptor, alpha and thyroid hormone receptor, beta [GeneSymbol:THRA & THRB | GeneID:7067 & 7068 | Uniprot_SwissProt_Accession:P10827 & P10828]. Thyroid receptor (TR), a nuclear hormone receptor, plays an important role in development, proliferation, differentiation, metabolism, brain function, and cardiovascular system. TR-interacting compounds have been shown to disrupt thyroid homeostasis.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 645, + "assayName": "TOX21_TR_LUC_GH3_Antagonist_Followup", + "assayDesc": "TOX21_TR_LUC_GH3_Agonist_Followup is a secondary assay for the TOX21_TR_LUC_GH3_Agonist assay. TOX21_TR_LUC_GH3_Agonist_Followup is a cell-based, single-readout assay that uses GH3, a rat pituitary gland cell line, with measurements taken at 28 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 28.0, + "organismId": 10116, + "organism": "rat", + "tissue": "pituitary gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "GH3", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 321, + "geneName": "thyroid hormone receptor, alpha", + "description": null, + "geneSymbol": "THRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7067, + "officialSymbol": "THRA", + "officialFullName": "thyroid hormone receptor, alpha", + "uniprotAccessionNumber": "P10827" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2228, + "assayComponentEndpointName": "TOX21_TRA_COA_Agonist_Followup_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRA_COA_Agonist_Followup_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRA_COA_Agonist_Followup_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRA. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2289, + "assayComponentName": "TOX21_TRA_COA_Agonist_Followup_ch1", + "assayComponentDesc": "TOX21_TRA_COA_Agonist_Followup_ch1 is an assay readout measuring emission signals generated by coactivator recruitment. The ch1 signal is derived from donor emission and is used to calculate TR-FRET ratio of acceptor emission (ch2) to donor emission (ch1).", + "assayComponentTargetDesc": "Terbium-labeled anti-GST antibody indirectly labels TR by binding to the GST tag. Binding of the agonist to the TR causes a conformational change that results in an increase in the affinity of the TR for a coactivator peptide. The close proximity of the fluorescein-labeled SRC-2 coactivator peptide to the terbium-labeled antibody causes an increase in the TR-FRET signal.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescein-labeled SRC-2 coactivator peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 646, + "assayName": "TOX21_TRA_COA_Agonist_Followup", + "assayDesc": "TOX21_TRa_COA_Agonist_Followup is a secondary assay for specificity for the TOX21_TR_GH3_LUC_Agonist assay. The LanthaScreen TR-FRET TR coactivator assay kits were used to determine TR activity in a cell-free functional assay. A time-resolved fluorescence resonance energy transfer (TR-FRET) signal was indicative of coactivator (SRC-2) recruitment.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2229, + "assayComponentEndpointName": "TOX21_TRA_COA_Agonist_Followup_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRA_COA_Agonist_Followup_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRA_COA_Agonist_Followup_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRA. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2290, + "assayComponentName": "TOX21_TRA_COA_Agonist_Followup_ch2", + "assayComponentDesc": "TOX21_TRA_COA_Agonist_Followup_ch2 is an assay readout measuring emission signals generated by coactivator (SRC-2) recruitment. The ch2 signal is derived from acceptor emission and is used to calculate TR-FRET ratio of acceptor emission (ch2) to donor emission (ch1).", + "assayComponentTargetDesc": "Terbium-labeled anti-GST antibody indirectly labels TR by binding to the GST tag. Binding of the agonist to the TR causes a conformational change that results in an increase in the affinity of the TR for a coactivator peptide. The close proximity of the fluorescein-labeled SRC-2 coactivator peptide to the terbium-labeled antibody causes an increase in the TR-FRET signal.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescein-labeled SRC-2 coactivator peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 646, + "assayName": "TOX21_TRA_COA_Agonist_Followup", + "assayDesc": "TOX21_TRa_COA_Agonist_Followup is a secondary assay for specificity for the TOX21_TR_GH3_LUC_Agonist assay. The LanthaScreen TR-FRET TR coactivator assay kits were used to determine TR activity in a cell-free functional assay. A time-resolved fluorescence resonance energy transfer (TR-FRET) signal was indicative of coactivator (SRC-2) recruitment.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2230, + "assayComponentEndpointName": "TOX21_TRA_COA_Agonist_Followup_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRA_COA_Agonist_Followup_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRA_COA_Agonist_Followup_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRA. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2291, + "assayComponentName": "TOX21_TRA_COA_Agonist_Followup_ratio", + "assayComponentDesc": "TOX21_TRA_COA_Agonist_Followup_ratio is assay component calculated in the TOX21_TRA_COA_Agonist_Followup assay. The TR-FRET ratio of acceptor emission (ch2) to donor emission (ch1) is indicative of the resonance energy transfer to the fluorescein tag on the coactivator peptide following recruitment to the receptor.", + "assayComponentTargetDesc": "Terbium-labeled anti-GST antibody indirectly labels TR by binding to the GST tag. Binding of the agonist to the TR causes a conformational change that results in an increase in the affinity of the TR for a coactivator peptide. The close proximity of the fluorescein-labeled SRC-2 coactivator peptide to the terbium-labeled antibody causes an increase in the TR-FRET signal.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "coactivator recruitment", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescein-labeled SRC-2 coactivator peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 646, + "assayName": "TOX21_TRA_COA_Agonist_Followup", + "assayDesc": "TOX21_TRa_COA_Agonist_Followup is a secondary assay for specificity for the TOX21_TR_GH3_LUC_Agonist assay. The LanthaScreen TR-FRET TR coactivator assay kits were used to determine TR activity in a cell-free functional assay. A time-resolved fluorescence resonance energy transfer (TR-FRET) signal was indicative of coactivator (SRC-2) recruitment.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 321, + "geneName": "thyroid hormone receptor, alpha", + "description": null, + "geneSymbol": "THRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7067, + "officialSymbol": "THRA", + "officialFullName": "thyroid hormone receptor, alpha", + "uniprotAccessionNumber": "P10827" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2231, + "assayComponentEndpointName": "TOX21_TRA_COA_Antagonist_Followup_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRA_COA_Antagonist_Followup_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRA_COA_Antagonist_Followup_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRA. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2292, + "assayComponentName": "TOX21_TRA_COA_Antagonist_Followup_ch1", + "assayComponentDesc": "TOX21_TRA_COA_Antagonist_Followup_ch1 is an assay readout measuring emission signals generated by coactivator recruitment. The ch1 signal is derived from donor emission and is used to calculate TR-FRET ratio of acceptor emission (ch2) to donor emission (ch1).", + "assayComponentTargetDesc": "Terbium-labeled anti-GST antibody indirectly labels TR by binding to the GST tag. Binding of the antagonist to the TR causes a conformational change that results in an decrease in the affinity of the TR for a coactivator peptide. The close proximity of the fluorescein-labeled SRC-2 coactivator peptide to the terbium-labeled antibody causes an increase in the TR-FRET signal.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescein-labeled SRC-2 coactivator peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 647, + "assayName": "TOX21_TRA_COA_Antagonist_Followup", + "assayDesc": "TOX21_TRa_COA_Antagonist_Followup is a secondary assay for specificity for the TOX21_TR_GH3_LUC_Agonist assay. The LanthaScreen TR-FRET TR coactivator assay kits were used to determine TR activity in a cell-free functional assay. A time-resolved fluorescence resonance energy transfer (TR-FRET) signal was indicative of coactivator (SRC-2) recruitment.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2232, + "assayComponentEndpointName": "TOX21_TRA_COA_Antagonist_Followup_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRA_COA_Antagonist_Followup_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRA_COA_Antagonist_Followup_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRA. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2293, + "assayComponentName": "TOX21_TRA_COA_Antagonist_Followup_ch2", + "assayComponentDesc": "TOX21_TRA_COA_Antagonist_Followup_ch2 is an assay readout measuring emission signals generated by coactivator (SRC-2) recruitment. The ch2 signal is derived from acceptor emission and is used to calculate TR-FRET ratio of acceptor emission (ch2) to donor emission (ch1).", + "assayComponentTargetDesc": "Terbium-labeled anti-GST antibody indirectly labels TR by binding to the GST tag. Binding of the antagonist to the TR causes a conformational change that results in an decrease in the affinity of the TR for a coactivator peptide. The close proximity of the fluorescein-labeled SRC-2 coactivator peptide to the terbium-labeled antibody causes an increase in the TR-FRET signal.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescein-labeled SRC-2 coactivator peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 647, + "assayName": "TOX21_TRA_COA_Antagonist_Followup", + "assayDesc": "TOX21_TRa_COA_Antagonist_Followup is a secondary assay for specificity for the TOX21_TR_GH3_LUC_Agonist assay. The LanthaScreen TR-FRET TR coactivator assay kits were used to determine TR activity in a cell-free functional assay. A time-resolved fluorescence resonance energy transfer (TR-FRET) signal was indicative of coactivator (SRC-2) recruitment.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2233, + "assayComponentEndpointName": "TOX21_TRA_COA_Antagonist_Followup_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRA_COA_Antagonist_Followup_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRA_COA_Antagonist_Followup_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRA. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2294, + "assayComponentName": "TOX21_TRA_COA_Antagonist_Followup_ratio", + "assayComponentDesc": "TOX21_TRA_COA_Antagonist_Followup_ratio is assay component calculated in the TOX21_TRA_COA_Antagonist_Followup assay. The TR-FRET ratio of acceptor emission (ch2) to donor emission (ch1) is indicative of the resonance energy transfer to the fluorescein tag on the coactivator peptide following recruitment to the receptor.", + "assayComponentTargetDesc": "Terbium-labeled anti-GST antibody indirectly labels TR by binding to the GST tag. Binding of the antagonist to the TR causes a conformational change that results in an decrease in the affinity of the TR for a coactivator peptide. The close proximity of the fluorescein-labeled SRC-2 coactivator peptide to the terbium-labeled antibody causes an increase in the TR-FRET signal.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "coactivator recruitment", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescein-labeled SRC-2 coactivator peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 647, + "assayName": "TOX21_TRA_COA_Antagonist_Followup", + "assayDesc": "TOX21_TRa_COA_Antagonist_Followup is a secondary assay for specificity for the TOX21_TR_GH3_LUC_Agonist assay. The LanthaScreen TR-FRET TR coactivator assay kits were used to determine TR activity in a cell-free functional assay. A time-resolved fluorescence resonance energy transfer (TR-FRET) signal was indicative of coactivator (SRC-2) recruitment.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 321, + "geneName": "thyroid hormone receptor, alpha", + "description": null, + "geneSymbol": "THRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7067, + "officialSymbol": "THRA", + "officialFullName": "thyroid hormone receptor, alpha", + "uniprotAccessionNumber": "P10827" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2234, + "assayComponentEndpointName": "TOX21_TRB_BLA_Agonist_Followup_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRB_BLA_Agonist_Followup_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRB_BLA_Agonist_Followup_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRB. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2295, + "assayComponentName": "TOX21_TRB_BLA_Agonist_Followup_ch1", + "assayComponentDesc": "TOX21_TRB_BLA_Agonist_Followup_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Thyroid receptor (TR), a nuclear hormone receptor, plays an important role in development, proliferation, differentiation, metabolism, brain function, and cardiovascular system. TR-interacting compounds have been shown to disrupt thyroid homeostasis.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 648, + "assayName": "TOX21_TRB_BLA_Agonist_Followup", + "assayDesc": "The GeneBLAzer TRb-UAS-bla HEK293T assay kit for human TRb (ThermoFisherScientific Catalog No. K1684) was used as a secondary assay for specificity (TRb-bla). This assay contained the ligand-binding domain (LBD) of the human TRb fused to the DNA-binding domain of GAL4 stably integrated in the GeneBLAzer UAS-bla HEK293Tcell line. The reporter gene, b-lactamase, is under the transcriptional control of a UAS that binds the GAL4 DNA-binding domain. A cell viability assay was run in parallel for these cells as well using the CellTiter-Glo viability assay kit.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "TRb-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2235, + "assayComponentEndpointName": "TOX21_TRB_BLA_Agonist_Followup_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRB_BLA_Agonist_Followup_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRB_BLA_Agonist_Followup_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRB. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2296, + "assayComponentName": "TOX21_TRB_BLA_Agonist_Followup_ch2", + "assayComponentDesc": "TOX21_TRB_BLA_Agonist_Followup_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Thyroid receptor (TR), a nuclear hormone receptor, plays an important role in development, proliferation, differentiation, metabolism, brain function, and cardiovascular system. TR-interacting compounds have been shown to disrupt thyroid homeostasis.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 648, + "assayName": "TOX21_TRB_BLA_Agonist_Followup", + "assayDesc": "The GeneBLAzer TRb-UAS-bla HEK293T assay kit for human TRb (ThermoFisherScientific Catalog No. K1684) was used as a secondary assay for specificity (TRb-bla). This assay contained the ligand-binding domain (LBD) of the human TRb fused to the DNA-binding domain of GAL4 stably integrated in the GeneBLAzer UAS-bla HEK293Tcell line. The reporter gene, b-lactamase, is under the transcriptional control of a UAS that binds the GAL4 DNA-binding domain. A cell viability assay was run in parallel for these cells as well using the CellTiter-Glo viability assay kit.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "TRb-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2236, + "assayComponentEndpointName": "TOX21_TRB_BLA_Agonist_Followup_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRB_BLA_Agonist_Followup_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRB_BLA_Agonist_Followup_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRB. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2297, + "assayComponentName": "TOX21_TRB_BLA_Agonist_Followup_ratio", + "assayComponentDesc": "TOX21_TRB_BLA_Agonist_Followup_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "Thyroid receptor (TR), a nuclear hormone receptor, plays an important role in development, proliferation, differentiation, metabolism, brain function, and cardiovascular system. TR-interacting compounds have been shown to disrupt thyroid homeostasis.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 648, + "assayName": "TOX21_TRB_BLA_Agonist_Followup", + "assayDesc": "The GeneBLAzer TRb-UAS-bla HEK293T assay kit for human TRb (ThermoFisherScientific Catalog No. K1684) was used as a secondary assay for specificity (TRb-bla). This assay contained the ligand-binding domain (LBD) of the human TRb fused to the DNA-binding domain of GAL4 stably integrated in the GeneBLAzer UAS-bla HEK293Tcell line. The reporter gene, b-lactamase, is under the transcriptional control of a UAS that binds the GAL4 DNA-binding domain. A cell viability assay was run in parallel for these cells as well using the CellTiter-Glo viability assay kit.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "TRb-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 322, + "geneName": "thyroid hormone receptor, beta", + "description": null, + "geneSymbol": "THRB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7068, + "officialSymbol": "THRB", + "officialFullName": "thyroid hormone receptor, beta", + "uniprotAccessionNumber": "P10828" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2237, + "assayComponentEndpointName": "TOX21_TRB_BLA_Agonist_Followup_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint TOX21_TRB_BLA_Agonist_Followup_viability was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2298, + "assayComponentName": "TOX21_TRB_BLA_Agonist_Followup_viability", + "assayComponentDesc": "TOX21_TRB_BLA_Agonist_Followup_viability is a component of the TOX21_TRB_BLA_Agonist_Followup assay. This component measures cell viability using the CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 648, + "assayName": "TOX21_TRB_BLA_Agonist_Followup", + "assayDesc": "The GeneBLAzer TRb-UAS-bla HEK293T assay kit for human TRb (ThermoFisherScientific Catalog No. K1684) was used as a secondary assay for specificity (TRb-bla). This assay contained the ligand-binding domain (LBD) of the human TRb fused to the DNA-binding domain of GAL4 stably integrated in the GeneBLAzer UAS-bla HEK293Tcell line. The reporter gene, b-lactamase, is under the transcriptional control of a UAS that binds the GAL4 DNA-binding domain. A cell viability assay was run in parallel for these cells as well using the CellTiter-Glo viability assay kit.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "TRb-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2238, + "assayComponentEndpointName": "TOX21_TRB_BLA_Antagonist_Followup_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRB_BLA_Antagonist_Followup_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRB_BLA_Antagonist_Followup_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene THRB. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2299, + "assayComponentName": "TOX21_TRB_BLA_Antagonist_Followup_ch1", + "assayComponentDesc": "TOX21_TRB_BLA_Antagonist_Followup_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Thyroid receptor (TR), a nuclear hormone receptor, plays an important role in development, proliferation, differentiation, metabolism, brain function, and cardiovascular system. TR-interacting compounds have been shown to disrupt thyroid homeostasis.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 649, + "assayName": "TOX21_TRB_BLA_Antagonist_Followup", + "assayDesc": "The GeneBLAzer TRb-UAS-bla HEK293T assay kit for human TRb (ThermoFisherScientific Catalog No. K1684) was used as a secondary assay for specificity (TRb-bla).This assay contained the ligand-binding domain (LBD) of the human TRb fused to the DNA-binding domain of GAL4 stably integrated in the GeneBLAzer UAS-bla HEK293Tcell line. The reporter gene, b-lactamase, is under the transcriptional control of a UAS that binds the GAL4 DNA-binding domain. A cell viability assay was run in parallel for these cells as well using the CellTiter-Glo viability assay kit.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "TRb-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2239, + "assayComponentEndpointName": "TOX21_TRB_BLA_Antagonist_Followup_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRB_BLA_Antagonist_Followup_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRB_BLA_Antagonist_Followup_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRB. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2300, + "assayComponentName": "TOX21_TRB_BLA_Antagonist_Followup_ch2", + "assayComponentDesc": "TOX21_TRB_BLA_Antagonist_Followup_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Thyroid receptor (TR), a nuclear hormone receptor, plays an important role in development, proliferation, differentiation, metabolism, brain function, and cardiovascular system. TR-interacting compounds have been shown to disrupt thyroid homeostasis.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 649, + "assayName": "TOX21_TRB_BLA_Antagonist_Followup", + "assayDesc": "The GeneBLAzer TRb-UAS-bla HEK293T assay kit for human TRb (ThermoFisherScientific Catalog No. K1684) was used as a secondary assay for specificity (TRb-bla).This assay contained the ligand-binding domain (LBD) of the human TRb fused to the DNA-binding domain of GAL4 stably integrated in the GeneBLAzer UAS-bla HEK293Tcell line. The reporter gene, b-lactamase, is under the transcriptional control of a UAS that binds the GAL4 DNA-binding domain. A cell viability assay was run in parallel for these cells as well using the CellTiter-Glo viability assay kit.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "TRb-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2240, + "assayComponentEndpointName": "TOX21_TRB_BLA_Antagonist_Followup_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRB_BLA_Antagonist_Followup_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRB_BLA_Antagonist_Followup_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRB. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2301, + "assayComponentName": "TOX21_TRB_BLA_Antagonist_Followup_ratio", + "assayComponentDesc": "TOX21_TRB_BLA_Antagonist_Followup_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "Thyroid receptor (TR), a nuclear hormone receptor, plays an important role in development, proliferation, differentiation, metabolism, brain function, and cardiovascular system. TR-interacting compounds have been shown to disrupt thyroid homeostasis.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 649, + "assayName": "TOX21_TRB_BLA_Antagonist_Followup", + "assayDesc": "The GeneBLAzer TRb-UAS-bla HEK293T assay kit for human TRb (ThermoFisherScientific Catalog No. K1684) was used as a secondary assay for specificity (TRb-bla).This assay contained the ligand-binding domain (LBD) of the human TRb fused to the DNA-binding domain of GAL4 stably integrated in the GeneBLAzer UAS-bla HEK293Tcell line. The reporter gene, b-lactamase, is under the transcriptional control of a UAS that binds the GAL4 DNA-binding domain. A cell viability assay was run in parallel for these cells as well using the CellTiter-Glo viability assay kit.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "TRb-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 322, + "geneName": "thyroid hormone receptor, beta", + "description": null, + "geneSymbol": "THRB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7068, + "officialSymbol": "THRB", + "officialFullName": "thyroid hormone receptor, beta", + "uniprotAccessionNumber": "P10828" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2241, + "assayComponentEndpointName": "TOX21_TRB_BLA_Antagonist_Followup_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_TRB_BLA_Antagonist_Followup_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2302, + "assayComponentName": "TOX21_TRB_BLA_Antagonist_Followup_viability", + "assayComponentDesc": "TOX21_TRB_BLA_Antagonist_Followup_viability is a component of the TOX21_TRB_BLA_Antagonist_Followup assay. This component measures cell viability using the CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 649, + "assayName": "TOX21_TRB_BLA_Antagonist_Followup", + "assayDesc": "The GeneBLAzer TRb-UAS-bla HEK293T assay kit for human TRb (ThermoFisherScientific Catalog No. K1684) was used as a secondary assay for specificity (TRb-bla).This assay contained the ligand-binding domain (LBD) of the human TRb fused to the DNA-binding domain of GAL4 stably integrated in the GeneBLAzer UAS-bla HEK293Tcell line. The reporter gene, b-lactamase, is under the transcriptional control of a UAS that binds the GAL4 DNA-binding domain. A cell viability assay was run in parallel for these cells as well using the CellTiter-Glo viability assay kit.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "TRb-UAS-bla-HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2242, + "assayComponentEndpointName": "TOX21_TRB_COA_Agonist_Followup_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRB_COA_Agonist_Followup_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRB_COA_Agonist_Followup_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRB. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2303, + "assayComponentName": "TOX21_TRB_COA_Agonist_Followup_ch1", + "assayComponentDesc": "TOX21_TRB_COA_Agonist_Followup_ch1 is an assay readout measuring emission signals generated by coactivator recruitment. The ch1 signal is derived from donor emission and is used to calculate TR-FRET ratio of acceptor emission (ch2) to donor emission (ch1).", + "assayComponentTargetDesc": "Terbium-labeled anti-GST antibody indirectly labels TR by binding to the GST tag. Binding of the agonist to the TR causes a conformational change that results in an increase in the affinity of the TR for a coactivator peptide. The close proximity of the fluorescein-labeled SRC-2 coactivator peptide to the terbium-labeled antibody causes an increase in the TR-FRET signal.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescein-labeled SRC-2 coactivator peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 650, + "assayName": "TOX21_TRB_COA_Agonist_Followup", + "assayDesc": "TOX21_TRb_COA_Agonist_Followup is a secondary assay for specificity for the TOX21_TR_GH3_LUC_Agonist assay. The LanthaScreen TR-FRET TR coactivator assay kits were used to determine TR activity in a cell-free functional assay. A time-resolved fluorescence resonance energy transfer (TR-FRET) signal was indicative of coactivator (SRC-2) recruitment.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2243, + "assayComponentEndpointName": "TOX21_TRB_COA_Agonist_Followup_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRB_COA_Agonist_Followup_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRB_COA_Antagonist_Followup_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRB. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2304, + "assayComponentName": "TOX21_TRB_COA_Agonist_Followup_ch2", + "assayComponentDesc": "TOX21_TRB_COA_Agonist_Followup_ch2 is an assay readout measuring emission signals generated by coactivator (SRC-2) recruitment. The ch2 signal is derived from acceptor emission and is used to calculate TR-FRET ratio of acceptor emission (ch2) to donor emission (ch1).", + "assayComponentTargetDesc": "Terbium-labeled anti-GST antibody indirectly labels TR by binding to the GST tag. Binding of the agonist to the TR causes a conformational change that results in an increase in the affinity of the TR for a coactivator peptide. The close proximity of the fluorescein-labeled SRC-2 coactivator peptide to the terbium-labeled antibody causes an increase in the TR-FRET signal.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescein-labeled SRC-2 coactivator peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 650, + "assayName": "TOX21_TRB_COA_Agonist_Followup", + "assayDesc": "TOX21_TRb_COA_Agonist_Followup is a secondary assay for specificity for the TOX21_TR_GH3_LUC_Agonist assay. The LanthaScreen TR-FRET TR coactivator assay kits were used to determine TR activity in a cell-free functional assay. A time-resolved fluorescence resonance energy transfer (TR-FRET) signal was indicative of coactivator (SRC-2) recruitment.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 1357, + "assayComponentEndpointName": "ATG_COUP_TF1_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_COUP_TF1_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR2F1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 924, + "assayComponentName": "ATG_COUP_TF1_TRANS2", + "assayComponentDesc": "ATG_COUP_TF1_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-TF1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 316, + "geneName": "nuclear receptor subfamily 2, group F, member 1", + "description": null, + "geneSymbol": "NR2F1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7025, + "officialSymbol": "NR2F1", + "officialFullName": "nuclear receptor subfamily 2, group F, member 1", + "uniprotAccessionNumber": "P10589" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1358, + "assayComponentEndpointName": "ATG_NOR1_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_NOR1_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR4A3. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 925, + "assayComponentName": "ATG_NOR1_TRANS2", + "assayComponentDesc": "ATG_NOR1_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-NOR1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 341, + "geneName": "nuclear receptor subfamily 4, group A, member 3", + "description": null, + "geneSymbol": "NR4A3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8013, + "officialSymbol": "NR4A3", + "officialFullName": "nuclear receptor subfamily 4, group A, member 3", + "uniprotAccessionNumber": "Q92570" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1359, + "assayComponentEndpointName": "ATG_TR4_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_TR4_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR2C2. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 926, + "assayComponentName": "ATG_TR4_TRANS2", + "assayComponentDesc": "ATG_TR4_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-TR4 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 331, + "geneName": "nuclear receptor subfamily 2, group C, member 2", + "description": null, + "geneSymbol": "NR2C2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7182, + "officialSymbol": "NR2C2", + "officialFullName": "nuclear receptor subfamily 2, group C, member 2", + "uniprotAccessionNumber": "P49116" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1360, + "assayComponentEndpointName": "ATG_DAX1_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_DAX1_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR0B1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 927, + "assayComponentName": "ATG_DAX1_TRANS2", + "assayComponentDesc": "ATG_DAX1_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-DAX1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 20, + "geneName": "nuclear receptor subfamily 0, group B, member 1", + "description": null, + "geneSymbol": "NR0B1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 190, + "officialSymbol": "NR0B1", + "officialFullName": "nuclear receptor subfamily 0, group B, member 1", + "uniprotAccessionNumber": "P51843" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1361, + "assayComponentEndpointName": "ATG_Rev_ERB_B_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_Rev_ERB_B_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR1D2. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 928, + "assayComponentName": "ATG_Rev_ERB_B_TRANS2", + "assayComponentDesc": "ATG_Rev_ERB_B_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-erb-b RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 358, + "geneName": "nuclear receptor subfamily 1, group D, member 2", + "description": null, + "geneSymbol": "NR1D2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9975, + "officialSymbol": "NR1D2", + "officialFullName": "nuclear receptor subfamily 1, group D, member 2", + "uniprotAccessionNumber": "Q14995" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1362, + "assayComponentEndpointName": "ATG_RORa_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_RORa_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RORA. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 929, + "assayComponentName": "ATG_RORa_TRANS2", + "assayComponentDesc": "ATG_RORa_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-ROR-a RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 284, + "geneName": "RAR-related orphan receptor A", + "description": null, + "geneSymbol": "RORA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6095, + "officialSymbol": "RORA", + "officialFullName": "RAR-related orphan receptor A", + "uniprotAccessionNumber": "P35398" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1363, + "assayComponentEndpointName": "ATG_PR_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_PR_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PGR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 930, + "assayComponentName": "ATG_PR_TRANS2", + "assayComponentDesc": "ATG_PR_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-PR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1364, + "assayComponentEndpointName": "ATG_RXRg_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_RXRg_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RXRG. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 931, + "assayComponentName": "ATG_RXRg_TRANS2", + "assayComponentDesc": "ATG_RXRg_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-RXR-g RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 6215, + "geneName": "retinoid X receptor gamma", + "description": null, + "geneSymbol": "RXRG", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 6258, + "officialSymbol": "RXRG", + "officialFullName": "retinoid X receptor gamma", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1365, + "assayComponentEndpointName": "ATG_SF_1_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_SF_1_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR5A1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 932, + "assayComponentName": "ATG_SF_1_TRANS2", + "assayComponentDesc": "ATG_SF_1_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-SF1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 136, + "geneName": "nuclear receptor subfamily 5, group A, member 1", + "description": null, + "geneSymbol": "NR5A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2516, + "officialSymbol": "NR5A1", + "officialFullName": "nuclear receptor subfamily 5, group A, member 1", + "uniprotAccessionNumber": "Q13285" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1366, + "assayComponentEndpointName": "ATG_SHP_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_SHP_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR0B2. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 933, + "assayComponentName": "ATG_SHP_TRANS2", + "assayComponentDesc": "ATG_SHP_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-SHP RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 342, + "geneName": "nuclear receptor subfamily 0, group B, member 2", + "description": null, + "geneSymbol": "NR0B2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8431, + "officialSymbol": "NR0B2", + "officialFullName": "nuclear receptor subfamily 0, group B, member 2", + "uniprotAccessionNumber": "Q15466" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1367, + "assayComponentEndpointName": "ATG_ERb_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_ERb_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ESR2. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 934, + "assayComponentName": "ATG_ERb_TRANS2", + "assayComponentDesc": "ATG_ERb_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-ER-b RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 118, + "geneName": "estrogen receptor 2 (ER beta)", + "description": null, + "geneSymbol": "ESR2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2100, + "officialSymbol": "ESR2", + "officialFullName": "estrogen receptor 2 (ER beta)", + "uniprotAccessionNumber": "Q92731" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1368, + "assayComponentEndpointName": "ATG_TLX_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_TLX_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR2E1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 935, + "assayComponentName": "ATG_TLX_TRANS2", + "assayComponentDesc": "ATG_TLX_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-TLX RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 326, + "geneName": "nuclear receptor subfamily 2, group E, member 1", + "description": null, + "geneSymbol": "NR2E1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7101, + "officialSymbol": "NR2E1", + "officialFullName": "nuclear receptor subfamily 2, group E, member 1", + "uniprotAccessionNumber": "Q9Y466" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 2251, + "assayComponentEndpointName": "TOX21_TR_RXR_BLA_Agonist_Followup_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TR_RXR_BLA_Agonist_Followup_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TR_RXR_BLA_Agonist_Followup_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene RXRA Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "9-cis-Retinoic acid", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2312, + "assayComponentName": "TOX21_TR_RXR_BLA_Agonist_Followup_ch1", + "assayComponentDesc": "TOX21_TR_RXR_BLA_Agonist_Followup_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Activity at the RXR portion of the TR:RXR heterodimer is specifically screened to assess contribution in GH3-TRE-Luc signal in TOX21_TR_LUC_GH3 assays.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 653, + "assayName": "TOX21_TR_RXR_BLA_Agonist_Followup", + "assayDesc": "GeneBLAzer RXRa-UAS-bla HEK293T assay (RXRa-bla) (ThermoFisherScientific Catalog No. K1697) was run in qHTS 1536 well format as a secondary assay for specificity of response in the TOX21_TR_GH3_LUC_Agonist assay.", + "timepointHr": 16.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "RXRa-UAS-bla HEK 293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2252, + "assayComponentEndpointName": "TOX21_TR_RXR_BLA_Agonist_Followup_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TR_RXR_BLA_Agonist_Followup_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TR_RXR_BLA_Agonist_Followup_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene RXRA. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "9-cis-Retinoic acid", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2313, + "assayComponentName": "TOX21_TR_RXR_BLA_Agonist_Followup_ch2", + "assayComponentDesc": "TOX21_TR_RXR_BLA_Agonist_Followup_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Activity at the RXR portion of the TR:RXR heterodimer is specifically screened to assess contribution in GH3-TRE-Luc signal in TOX21_TR_LUC_GH3 assays.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 653, + "assayName": "TOX21_TR_RXR_BLA_Agonist_Followup", + "assayDesc": "GeneBLAzer RXRa-UAS-bla HEK293T assay (RXRa-bla) (ThermoFisherScientific Catalog No. K1697) was run in qHTS 1536 well format as a secondary assay for specificity of response in the TOX21_TR_GH3_LUC_Agonist assay.", + "timepointHr": 16.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "RXRa-UAS-bla HEK 293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2253, + "assayComponentEndpointName": "TOX21_TR_RXR_BLA_Agonist_Followup_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TR_RXR_BLA_Agonist_Followup_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TR_RXR_BLA_Agonist_Followup_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene RXRA. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "9-cis-Retinoic acid", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2314, + "assayComponentName": "TOX21_TR_RXR_BLA_Agonist_Followup_ratio", + "assayComponentDesc": "TOX21_TR_RXR_BLA_Agonist_Followup_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "Activity at the RXR portion of the TR:RXR heterodimer is specifically screened to assess contribution in GH3-TRE-Luc signal in TOX21_TR_LUC_GH3 assays.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 653, + "assayName": "TOX21_TR_RXR_BLA_Agonist_Followup", + "assayDesc": "GeneBLAzer RXRa-UAS-bla HEK293T assay (RXRa-bla) (ThermoFisherScientific Catalog No. K1697) was run in qHTS 1536 well format as a secondary assay for specificity of response in the TOX21_TR_GH3_LUC_Agonist assay.", + "timepointHr": 16.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "RXRa-UAS-bla HEK 293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 287, + "geneName": "retinoid X receptor, alpha", + "description": null, + "geneSymbol": "RXRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6256, + "officialSymbol": "RXRA", + "officialFullName": "retinoid X receptor, alpha", + "uniprotAccessionNumber": "P19793" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2254, + "assayComponentEndpointName": "TOX21_TR_RXR_BLA_Agonist_Followup_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint TOX21_TR_RXR_BLA_Agonist_Followup_viability was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2315, + "assayComponentName": "TOX21_TR_RXR_BLA_Agonist_Followup_viability", + "assayComponentDesc": "TOX21_TR_RXR_BLA_Agonist_Followup_viability is a component of the TOX21_TR_RXR_BLA_Agonist_Followup assay. This component measures cell viability using the CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 653, + "assayName": "TOX21_TR_RXR_BLA_Agonist_Followup", + "assayDesc": "GeneBLAzer RXRa-UAS-bla HEK293T assay (RXRa-bla) (ThermoFisherScientific Catalog No. K1697) was run in qHTS 1536 well format as a secondary assay for specificity of response in the TOX21_TR_GH3_LUC_Agonist assay.", + "timepointHr": 16.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "RXRa-UAS-bla HEK 293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2255, + "assayComponentEndpointName": "TOX21_TR_RXR_BLA_Antagonist_Followup_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TR_RXR_BLA_Antagonist_Followup_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TR_RXR_BLA_Antagonist_Followup_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene RXRA Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM TA_Antagonist", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2316, + "assayComponentName": "TOX21_TR_RXR_BLA_Antagonist_Followup_ch1", + "assayComponentDesc": "TOX21_TR_RXR_BLA_Antagonist_Followup_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Activity at the RXR portion of the TR:RXR heterodimer is specifically screened to assess contribution in GH3-TRE-Luc signal in TOX21_TR_LUC_GH3 assays.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 654, + "assayName": "TOX21_TR_RXR_BLA_Antagonist_Followup", + "assayDesc": "GeneBLAzer RXRa-UAS-bla HEK293T assay (RXRa-bla) (ThermoFisherScientific Catalog No. K1697) was run in qHTS 1536 well format as a secondary assay for specificity of response in the TOX21_TR_GH3_LUC_Agonist assay.", + "timepointHr": 16.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "RXRa-UAS-bla HEK 293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2256, + "assayComponentEndpointName": "TOX21_TR_RXR_BLA_Antagonist_Followup_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TR_RXR_BLA_Antagonist_Followup_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TR_RXR_BLA_Antagonist_Followup_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene RXRA. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM TA_Antagonist", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2317, + "assayComponentName": "TOX21_TR_RXR_BLA_Antagonist_Followup_ch2", + "assayComponentDesc": "TOX21_TR_RXR_BLA_Antagonist_Followup_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Activity at the RXR portion of the TR:RXR heterodimer is specifically screened to assess contribution in GH3-TRE-Luc signal in TOX21_TR_LUC_GH3 assays.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 654, + "assayName": "TOX21_TR_RXR_BLA_Antagonist_Followup", + "assayDesc": "GeneBLAzer RXRa-UAS-bla HEK293T assay (RXRa-bla) (ThermoFisherScientific Catalog No. K1697) was run in qHTS 1536 well format as a secondary assay for specificity of response in the TOX21_TR_GH3_LUC_Agonist assay.", + "timepointHr": 16.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "RXRa-UAS-bla HEK 293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2257, + "assayComponentEndpointName": "TOX21_TR_RXR_BLA_Antagonist_Followup_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TR_RXR_BLA_Antagonist_Followup_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TR_RXR_BLA_Antagonist_Followup_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene RXRA. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM T21_TR_RXR_BLA_Antagonist", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2318, + "assayComponentName": "TOX21_TR_RXR_BLA_Antagonist_Followup_ratio", + "assayComponentDesc": "TOX21_TR_RXR_BLA_Antagonist_Followup_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "Activity at the RXR portion of the TR:RXR heterodimer is specifically screened to assess contribution in GH3-TRE-Luc signal in TOX21_TR_LUC_GH3 assays.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 654, + "assayName": "TOX21_TR_RXR_BLA_Antagonist_Followup", + "assayDesc": "GeneBLAzer RXRa-UAS-bla HEK293T assay (RXRa-bla) (ThermoFisherScientific Catalog No. K1697) was run in qHTS 1536 well format as a secondary assay for specificity of response in the TOX21_TR_GH3_LUC_Agonist assay.", + "timepointHr": 16.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "RXRa-UAS-bla HEK 293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 287, + "geneName": "retinoid X receptor, alpha", + "description": null, + "geneSymbol": "RXRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6256, + "officialSymbol": "RXRA", + "officialFullName": "retinoid X receptor, alpha", + "uniprotAccessionNumber": "P19793" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2258, + "assayComponentEndpointName": "TOX21_TR_RXR_BLA_Antagonist_Followup_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint TOX21_TR_RXR_BLA_Antagonist_Followup_viability was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2319, + "assayComponentName": "TOX21_TR_RXR_BLA_Antagonist_Followup_viability", + "assayComponentDesc": "TOX21_TR_RXR_BLA_Antagonist_Followup_viability is a component of the TOX21_TR_RXR_BLA_Antagonist_Followup assay. This component measures cell viability using the CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 654, + "assayName": "TOX21_TR_RXR_BLA_Antagonist_Followup", + "assayDesc": "GeneBLAzer RXRa-UAS-bla HEK293T assay (RXRa-bla) (ThermoFisherScientific Catalog No. K1697) was run in qHTS 1536 well format as a secondary assay for specificity of response in the TOX21_TR_GH3_LUC_Agonist assay.", + "timepointHr": 16.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "RXRa-UAS-bla HEK 293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2277, + "assayComponentEndpointName": "NVS_ENZ_hPDE1A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPDE1A1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPDE1A1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PD1A1. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2320, + "assayComponentName": "NVS_ENZ_hPDE1A1", + "assayComponentDesc": "NVS_ENZ_hPDE1A1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE1A1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic AMP --> Flourescent 5?-AMP] involving the key substrate [Fluorescent cyclic AMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 1A [GeneSymbol:PDE1A | GeneID:5136 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic AMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 655, + "assayName": "NVS_ENZ_hPDE1A1", + "assayDesc": "NVS_ENZ_hPDE1A1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": null, + "dilutionSolventPercentMax": null, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 5353, + "geneName": "phosphodiesterase 1A", + "description": null, + "geneSymbol": "PDE1A", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5136, + "officialSymbol": "PDE1A", + "officialFullName": "phosphodiesterase 1A", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 2279, + "assayComponentEndpointName": "NVS_ENZ_hPDE1B1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPDE1B1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPDE1B1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PDE1B1. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2321, + "assayComponentName": "NVS_ENZ_hPDE1B1", + "assayComponentDesc": "NVS_ENZ_hPDE1B1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE1B1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic AMP --> Flourescent 5?-AMP] involving the key substrate [Fluorescent cyclic AMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 1B [GeneSymbol:PDE1B | GeneID:5153 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic AMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 656, + "assayName": "NVS_ENZ_hPDE1B1", + "assayDesc": "NVS_ENZ_hPDE1B1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": null, + "dilutionSolventPercentMax": null, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 5369, + "geneName": "phosphodiesterase 1B", + "description": null, + "geneSymbol": "PDE1B", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5153, + "officialSymbol": "PDE1B", + "officialFullName": "phosphodiesterase 1B", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 2281, + "assayComponentEndpointName": "NVS_ENZ_hPDE2A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPDE2A was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPDE2A, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PDE2A. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2322, + "assayComponentName": "NVS_ENZ_hPDE2A", + "assayComponentDesc": "NVS_ENZ_hPDE2A is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE2A assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic AMP --> Flourescent 5?-AMP] involving the key substrate [Fluorescent cyclic AMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 2A [GeneSymbol:PDE2A | GeneID:5138 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic AMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 657, + "assayName": "NVS_ENZ_hPDE2A", + "assayDesc": "NVS_ENZ_hPDE2A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": null, + "dilutionSolventPercentMax": null, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 5355, + "geneName": "phosphodiesterase 2A", + "description": null, + "geneSymbol": "PDE2A", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5138, + "officialSymbol": "PDE2A", + "officialFullName": "phosphodiesterase 2A", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 2283, + "assayComponentEndpointName": "NVS_ENZ_hPDE3A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPDE3A was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPDE3A, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PD3A. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2323, + "assayComponentName": "NVS_ENZ_hPDE3A", + "assayComponentDesc": "NVS_ENZ_hPDE3A is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE3A assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic AMP --> Flourescent 5?-AMP] involving the key substrate [Fluorescent cyclic AMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 3A [GeneSymbol:PDE3A | GeneID:5139 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic AMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 658, + "assayName": "NVS_ENZ_hPDE3A", + "assayDesc": "NVS_ENZ_hPDE3A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": null, + "dilutionSolventPercentMax": null, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 5356, + "geneName": "phosphodiesterase 3A", + "description": null, + "geneSymbol": "PDE3A", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5139, + "officialSymbol": "PDE3A", + "officialFullName": "phosphodiesterase 3A", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 1369, + "assayComponentEndpointName": "ATG_THRb_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_THRb_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene THRB. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 936, + "assayComponentName": "ATG_THRb_TRANS2", + "assayComponentDesc": "ATG_THRb_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-THR-b RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 322, + "geneName": "thyroid hormone receptor, beta", + "description": null, + "geneSymbol": "THRB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7068, + "officialSymbol": "THRB", + "officialFullName": "thyroid hormone receptor, beta", + "uniprotAccessionNumber": "P10828" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1370, + "assayComponentEndpointName": "ATG_EAR2_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_EAR2_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR2F6. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 937, + "assayComponentName": "ATG_EAR2_TRANS2", + "assayComponentDesc": "ATG_EAR2_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-EAR2 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 116, + "geneName": "nuclear receptor subfamily 2, group F, member 6", + "description": null, + "geneSymbol": "NR2F6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2063, + "officialSymbol": "NR2F6", + "officialFullName": "nuclear receptor subfamily 2, group F, member 6", + "uniprotAccessionNumber": "P10588" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1371, + "assayComponentEndpointName": "ATG_TR2_TRANS2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_TR2_TRANS2 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR2C1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 938, + "assayComponentName": "ATG_TR2_TRANS2", + "assayComponentDesc": "ATG_TR2_TRANS2 is one of 24 assay components measured or calculated from the ATG_TRANS2 assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factors.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-TR2 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 408, + "assayName": "ATG_TRANS2", + "assayDesc": "ATG_TRANS2 is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 330, + "geneName": "nuclear receptor subfamily 2, group C, member 1", + "description": null, + "geneSymbol": "NR2C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7181, + "officialSymbol": "NR2C1", + "officialFullName": "nuclear receptor subfamily 2, group C, member 1", + "uniprotAccessionNumber": "P13056" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1372, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_MORT", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_MORT was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_MORT, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 939, + "assayComponentName": "Tanguay_ZF_120hpf_MORT", + "assayComponentDesc": "Tanguay_ZF_120hpf_Mort is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_Mort assay. It is designed to make measurements of mortality as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Mortality is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "embryonic mortality", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "embryonic mortality", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 2285, + "assayComponentEndpointName": "NVS_ENZ_hPDE4B1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPDE4B1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPD4B1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PD4B1. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2324, + "assayComponentName": "NVS_ENZ_hPDE4B1", + "assayComponentDesc": "NVS_ENZ_hPDE4B1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE4B1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic AMP --> Flourescent 5?-AMP] involving the key substrate [Fluorescent cyclic AMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 4b, cAMP-specific [GeneSymbol:PDE4B | GeneID:5142 | .", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic AMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 659, + "assayName": "NVS_ENZ_hPDE4B1", + "assayDesc": "NVS_ENZ_hPDE4B1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": null, + "dilutionSolventPercentMax": null, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 5358, + "geneName": "phosphodiesterase 4B", + "description": null, + "geneSymbol": "PDE4B", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5142, + "officialSymbol": "PDE4B", + "officialFullName": "phosphodiesterase 4B", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 2287, + "assayComponentEndpointName": "NVS_ENZ_hPDE4C1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPD4C1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPD4C1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PDE4C1. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2325, + "assayComponentName": "NVS_ENZ_hPDE4C1", + "assayComponentDesc": "NVS_ENZ_hPDE4C1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE4C1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic AMP --> Flourescent 5?-AMP] involving the key substrate [Fluorescent cyclic AMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 4C, cAMP-specific [GeneSymbol:PDE4C | GeneID:5143 | .", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic AMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 660, + "assayName": "NVS_ENZ_hPDE4C1", + "assayDesc": "NVS_ENZ_hPDE4C1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": null, + "dilutionSolventPercentMax": null, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 5359, + "geneName": "phosphodiesterase 4C", + "description": null, + "geneSymbol": "PDE4C", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5143, + "officialSymbol": "PDE4C", + "officialFullName": "phosphodiesterase 4C", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 2289, + "assayComponentEndpointName": "NVS_ENZ_hPDE4D3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPDE4D3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPDE4D3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PDE4D3.\r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2326, + "assayComponentName": "NVS_ENZ_hPDE4D3", + "assayComponentDesc": "NVS_ENZ_hPDE4D3 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE4D3 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic AMP --> Flourescent 5?-AMP] involving the key substrate [Fluorescent cyclic AMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 4D, cAMP-specific [GeneSymbol:PDE4D | GeneID:5144 | .", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic AMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 661, + "assayName": "NVS_ENZ_hPDE4D3", + "assayDesc": "NVS_ENZ_hPDE4D3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": null, + "dilutionSolventPercentMax": null, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 5360, + "geneName": "phosphodiesterase 4D", + "description": null, + "geneSymbol": "PDE4D", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5144, + "officialSymbol": "PDE4D", + "officialFullName": "phosphodiesterase 4D", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 2291, + "assayComponentEndpointName": "NVS_ENZ_hPDE7A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPDE7A was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPDE7A, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PDE7A.\r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2327, + "assayComponentName": "NVS_ENZ_hPDE7A", + "assayComponentDesc": "NVS_ENZ_hPDE7A is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE7A assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic AMP --> Flourescent 5?-AMP] involving the key substrate [Fluorescent cyclic AMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 7A, cAMP-specific [GeneSymbol:PDE4D | GeneID:5150 | .", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic AMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 662, + "assayName": "NVS_ENZ_hPDE7A", + "assayDesc": "NVS_ENZ_hPDE7A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": null, + "dilutionSolventPercentMax": null, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 5366, + "geneName": "phosphodiesterase 7A", + "description": null, + "geneSymbol": "PDE7A", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5150, + "officialSymbol": "PDE7A", + "officialFullName": "phosphodiesterase 7A", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 2293, + "assayComponentEndpointName": "NVS_ENZ_hPDE8A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPDE8A1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPDE8A1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PDE8A1.\r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2328, + "assayComponentName": "NVS_ENZ_hPDE8A1", + "assayComponentDesc": "NVS_ENZ_hPDE8A is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE8A assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic AMP --> Flourescent 5?-AMP] involving the key substrate [Fluorescent cyclic AMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 8A, cAMP-specific [GeneSymbol:PDE4D | GeneID:5151 | .", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic AMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 663, + "assayName": "NVS_ENZ_hPDE8A1", + "assayDesc": "NVS_ENZ_hPDE8A1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": null, + "dilutionSolventPercentMax": null, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 5367, + "geneName": "phosphodiesterase 8A", + "description": null, + "geneSymbol": "PDE8A", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5151, + "officialSymbol": "PDE8A", + "officialFullName": "phosphodiesterase 8A", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 2295, + "assayComponentEndpointName": "NVS_ENZ_hPDE9A2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPDE9A2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPDE9A2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PDE9A2.\r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2329, + "assayComponentName": "NVS_ENZ_hPDE9A2", + "assayComponentDesc": "NVS_ENZ_hPDE9A is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE9A assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic AMP --> Flourescent 5?-AMP] involving the key substrate [Fluorescent cyclic AMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 9A, cAMP-specific [GeneSymbol:PDE4D | GeneID:5152 | .", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic AMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 664, + "assayName": "NVS_ENZ_hPDE9A2", + "assayDesc": "NVS_ENZ_hPDE9A2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": null, + "dilutionSolventPercentMax": null, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 5368, + "geneName": "phosphodiesterase 9A", + "description": null, + "geneSymbol": "PDE9A", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5152, + "officialSymbol": "PDE9A", + "officialFullName": "phosphodiesterase 9A", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 2297, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Viability_DMEM_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Viability_DMEM_6hr was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter to understand changes in cytotoxicity, gain-of-signal activity can be used to evaluate membrane integrity using propidium iodide dye exclusion. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM Nlity", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2330, + "assayComponentName": "CCTE_Harrill_HTTr_Viability_DMEM_6hr", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Viability assay. This was part of a pilot experiment. This is a cell-based assay that evaluates cell viability in MCF-7 cells cultured in DMEM + 10% fetal bovine serum. High content imaging is used to evaluate membrane integrity using propidium iodide dye exclusion. Measurements are taken at 6 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "propidium iodide is membrane impermeant and binds to DNA in dead/dying cells.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "membrane impermeable stain for DNA", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "propidium iodide", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "nuclear DNA", + "aid": 665, + "assayName": "CCTE_Harrill_HTTr_Viability", + "assayDesc": "This is a cell-based assay that evaluates cell viability using high content imaging to evaluate membrane integrity using propidium iodide dye exclusion in a 384 well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2298, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Viability_DMEM_12hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Viability_DMEM_12hr was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter to understand changes in cytotoxicity, gain-of-signal activity can be used to evaluate membrane integrity using propidium iodide dye exclusion. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM Nlity", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2334, + "assayComponentName": "CCTE_Harrill_HTTr_Viability_DMEM_12hr", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Viability assay. This was part of a pilot experiment. This is a cell-based assay that evaluates cell viability in MCF-7 cells cultured in DMEM + 10% fetal bovine serum. High content imaging is used to evaluate membrane integrity using propidium iodide dye exclusion. Measurements are taken at 12 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "propidium iodide is membrane impermeant and binds to DNA in dead/dying cells.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "membrane impermeable stain for DNA", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "propidium iodide", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "nuclear DNA", + "aid": 665, + "assayName": "CCTE_Harrill_HTTr_Viability", + "assayDesc": "This is a cell-based assay that evaluates cell viability using high content imaging to evaluate membrane integrity using propidium iodide dye exclusion in a 384 well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2299, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Viability_DMEM_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Viability_DMEM_24hr was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter to understand changes in cytotoxicity, gain-of-signal activity can be used to evaluate membrane integrity using propidium iodide dye exclusion. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM Nlity", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2335, + "assayComponentName": "CCTE_Harrill_HTTr_Viability_DMEM_24hr", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Viability assay. This was part of a pilot experiment. This is a cell-based assay that evaluates cell viability in MCF-7 cells cultured in DMEM + 10% fetal bovine serum. High content imaging is used to evaluate membrane integrity using propidium iodide dye exclusion. Measurements are taken at 24 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "propidium iodide is membrane impermeant and binds to DNA in dead/dying cells.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "membrane impermeable stain for DNA", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "propidium iodide", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "nuclear DNA", + "aid": 665, + "assayName": "CCTE_Harrill_HTTr_Viability", + "assayDesc": "This is a cell-based assay that evaluates cell viability using high content imaging to evaluate membrane integrity using propidium iodide dye exclusion in a 384 well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2300, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Viability_PRF_DMEM_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Viability_PRF_DMEM_6hr was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter to understand changes in cytotoxicity, gain-of-signal activity can be used to evaluate membrane integrity using propidium iodide dye exclusion. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM N6", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2331, + "assayComponentName": "CCTE_Harrill_HTTr_Viability_PRF_DMEM_6hr", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Viability assay. This was part of a pilot experiment. This is a cell-based assay that evaluates cell viability in MCF-7 cells cultured in phenol red-free DMEM + 10% charcoal-stripped fetal bovine serum. High content imaging is used to evaluate membrane integrity using propidium iodide dye exclusion. Measurements are taken at 6 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "propidium iodide is membrane impermeant and binds to DNA in dead/dying cells.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "membrane impermeable stain for DNA", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "propidium iodide", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "nuclear DNA", + "aid": 665, + "assayName": "CCTE_Harrill_HTTr_Viability", + "assayDesc": "This is a cell-based assay that evaluates cell viability using high content imaging to evaluate membrane integrity using propidium iodide dye exclusion in a 384 well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2301, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Viability_PRF_DMEM_12hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Viability_PRF_DMEM_12hr was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter to understand changes in cytotoxicity, gain-of-signal activity can be used to evaluate membrane integrity using propidium iodide dye exclusion. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM N12", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2336, + "assayComponentName": "CCTE_Harrill_HTTr_Viability_PRF_DMEM_12hr", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Viability assay. This was part of a pilot experiment. This is a cell-based assay that evaluates cell viability in MCF-7 cells cultured in phenol red-free DMEM + 10% charcoal-stripped fetal bovine serum. High content imaging is used to evaluate membrane integrity using propidium iodide dye exclusion. Measurements are taken at 12 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "propidium iodide is membrane impermeant and binds to DNA in dead/dying cells.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "membrane impermeable stain for DNA", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "propidium iodide", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "nuclear DNA", + "aid": 665, + "assayName": "CCTE_Harrill_HTTr_Viability", + "assayDesc": "This is a cell-based assay that evaluates cell viability using high content imaging to evaluate membrane integrity using propidium iodide dye exclusion in a 384 well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2302, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Viability_PRF_DMEM_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Viability_PRF_DMEM_24hr was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter to understand changes in cytotoxicity, gain-of-signal activity can be used to evaluate membrane integrity using propidium iodide dye exclusion. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM N24", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2337, + "assayComponentName": "CCTE_Harrill_HTTr_Viability_PRF_DMEM_24hr", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Viability assay. This was part of a pilot experiment. This is a cell-based assay that evaluates cell viability in MCF-7 cells cultured in phenol red-free DMEM + 10% charcoal-stripped fetal bovine serum. High content imaging is used to evaluate membrane integrity using propidium iodide dye exclusion. Measurements are taken at 24 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "propidium iodide is membrane impermeant and binds to DNA in dead/dying cells.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "membrane impermeable stain for DNA", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "propidium iodide", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "nuclear DNA", + "aid": 665, + "assayName": "CCTE_Harrill_HTTr_Viability", + "assayDesc": "This is a cell-based assay that evaluates cell viability using high content imaging to evaluate membrane integrity using propidium iodide dye exclusion in a 384 well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2303, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Apoptosis_DMEM_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Apoptosis_DMEM_6hr was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain-of-signal activity can be used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent to understand changes in apoptosis. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is apoptosis.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM Nosis", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "apoptosis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2332, + "assayComponentName": "CCTE_Harrill_HTTr_Apoptosis_DMEM_6hr", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Apoptosis assay. This was part of a pilot experiment. This is a cell-based assay that evaluates apoptosis in MCF-7 cells cultured in DMEM + 10% fetal bovine serum. High content imaging is used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent. Measurements are taken at 6 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "Caspase 3/7 kit", + "parameterReadoutType": "multiplexed", + "assayDesignType": "apoptosis reporter", + "assayDesignTypeSub": "Caspase 3/7 activity", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellEvent Caspase 3/7 Green detection reagent", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 666, + "assayName": "CCTE_Harrill_HTTr_Apoptosis", + "assayDesc": "This is a cell-based assay that evaluates apoptosis using high content imaging to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent in 384-well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2304, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Apoptosis_DMEM_12hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Apoptosis_DMEM_12hr was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain-of-signal activity can be used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent to understand changes in apoptosis. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is apoptosis.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM Nosis", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "apoptosis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2338, + "assayComponentName": "CCTE_Harrill_HTTr_Apoptosis_DMEM_12hr", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Apoptosis assay. This was part of a pilot experiment. This is a cell-based assay that evaluates apoptosis in MCF-7 cells cultured in DMEM + 10% fetal bovine serum. High content imaging is used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent. Measurements are taken at 12 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "Caspase 3/7 kit", + "parameterReadoutType": "multiplexed", + "assayDesignType": "apoptosis reporter", + "assayDesignTypeSub": "Caspase 3/7 activity", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellEvent Caspase 3/7 Green detection reagent", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "caspase", + "aid": 666, + "assayName": "CCTE_Harrill_HTTr_Apoptosis", + "assayDesc": "This is a cell-based assay that evaluates apoptosis using high content imaging to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent in 384-well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2305, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Apoptosis_DMEM_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Apoptosis_DMEM_24hr was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain-of-signal activity can be used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent to understand changes in apoptosis. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is apoptosis.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM Nosis", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "apoptosis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2339, + "assayComponentName": "CCTE_Harrill_HTTr_Apoptosis_DMEM_24hr", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Apoptosis assay. This was part of a pilot experiment. This is a cell-based assay that evaluates apoptosis in MCF-7 cells cultured in DMEM + 10% fetal bovine serum. High content imaging is used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent. Measurements are taken at 24 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "Caspase 3/7 kit", + "parameterReadoutType": "multiplexed", + "assayDesignType": "apoptosis reporter", + "assayDesignTypeSub": "Caspase 3/7 activity", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellEvent Caspase 3/7 Green detection reagent", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "caspase", + "aid": 666, + "assayName": "CCTE_Harrill_HTTr_Apoptosis", + "assayDesc": "This is a cell-based assay that evaluates apoptosis using high content imaging to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent in 384-well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2306, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Apoptosis_PRF_DMEM_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Apoptosis_PRF_DMEM_6hr was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain-of-signal activity can be used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent to understand changes in apoptosis. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is apoptosis.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM N6", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "apoptosis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2333, + "assayComponentName": "CCTE_Harrill_HTTr_Apoptosis_PRF_DMEM_6hr", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Apoptosis assay. This was part of a pilot experiment. This is a cell-based assay that evaluates apoptosis in MCF-7 cells cultured in phenol red-free DMEM + 10% charcoal-stripped fetal bovine serum. High content imaging is used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent. Measurements are taken at 6 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "Caspase 3/7 kit", + "parameterReadoutType": "multiplexed", + "assayDesignType": "apoptosis reporter", + "assayDesignTypeSub": "Caspase 3/7 activity", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellEvent Caspase 3/7 Green detection reagent", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 666, + "assayName": "CCTE_Harrill_HTTr_Apoptosis", + "assayDesc": "This is a cell-based assay that evaluates apoptosis using high content imaging to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent in 384-well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2307, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Apoptosis_PRF_DMEM_12hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Apoptosis_PRF_DMEM_12hr was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain-of-signal activity can be used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent to understand changes in apoptosis. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is apoptosis.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM N12", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "apoptosis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2340, + "assayComponentName": "CCTE_Harrill_HTTr_Apoptosis_PRF_DMEM_12hr", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Apoptosis assay. This was part of a pilot experiment. This is a cell-based assay that evaluates apoptosis in MCF-7 cells cultured in phenol red-free DMEM + 10% charcoal-stripped fetal bovine serum. High content imaging is used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent. Measurements are taken at 12 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "Caspase 3/7 kit", + "parameterReadoutType": "multiplexed", + "assayDesignType": "apoptosis reporter", + "assayDesignTypeSub": "Caspase 3/7 activity", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellEvent Caspase 3/7 Green detection reagent", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "caspase", + "aid": 666, + "assayName": "CCTE_Harrill_HTTr_Apoptosis", + "assayDesc": "This is a cell-based assay that evaluates apoptosis using high content imaging to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent in 384-well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2308, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Apoptosis_PRF_DMEM_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Apoptosis_PRF_DMEM_24hr was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain-of-signal activity can be used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent to understand changes in apoptosis. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is apoptosis.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM N24", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "apoptosis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2341, + "assayComponentName": "CCTE_Harrill_HTTr_Apoptosis_PRF_DMEM_24hr", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Apoptosis assay. This was part of a pilot experiment. This is a cell-based assay that evaluates apoptosis in MCF-7 cells cultured in phenol red-free DMEM + 10% charcoal-stripped fetal bovine serum. High content imaging is used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent. Measurements are taken at 24 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "Caspase 3/7 kit", + "parameterReadoutType": "multiplexed", + "assayDesignType": "apoptosis reporter", + "assayDesignTypeSub": "Caspase 3/7 activity", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellEvent Caspase 3/7 Green detection reagent", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "caspase", + "aid": 666, + "assayName": "CCTE_Harrill_HTTr_Apoptosis", + "assayDesc": "This is a cell-based assay that evaluates apoptosis using high content imaging to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent in 384-well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2309, + "assayComponentEndpointName": "CCTE_GLTED_hDIO1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_GLTED_hDIO1 was analyzed into 1 assay endpoint. This assay endpoint, CCTE_GLTED_hDIO1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene DIO1. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'deiodinase' intended target family, where the subfamily is 'deiodinase Type 1'.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "6-propyl-thiouracil (PTU)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "deiodinase", + "intendedTargetFamilySub": "deiodinase Type 1", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2342, + "assayComponentName": "CCTE_GLTED_hDIO1", + "assayComponentDesc": "CCTE_GLTED_hDIO1 is the assay component measured from the CCTE_GLTED_hDIO1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by spectrophotometry.", + "assayComponentTargetDesc": "Deiodinase enzymes play an essential role in converting thyroid hormones between active and inactive forms by deiodinating the pro-hormone thyroxine (T4) to the active hormone triiodothyronine (T3) and modifying T4 and T3 to inactive forms. DIO1 targets both the outer and inner rings, and thus can convert T4 to T3 or inactivate either of these thyroid hormones. ", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Colorimetric", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "3,3’,5’-triiodo-L-thyronine (reverse T3)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 667, + "assayName": "CCTE_GLTED_hDIO1", + "assayDesc": "CCTE_GLTED_hDIO1 is a cell-free, single-readout assay designed to test the inhibitory activity of chemicals toward human iodothyronine Deiodinase type 1 (DIO1) enzyme. Enzyme is incubated in presence of test chemical for 3 hours during which uninhibited enzyme liberates free iodide from substrate. Free iodide is measured in a second step using the Sandell-Kolthoff method.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "HEK293", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 24, + "assaySourceName": "CCTE_GLTED", + "assaySourceLongName": "CCTE Great Lakes Toxicology and Ecology Division", + "assaySourceDesc": "The EPA CCTE Great Lakes Toxicology and Ecology Division focuses on ecotoxicology and stressors of water resources, including devleopment and implementation of in vitro and in vivo assays.", + "gene": { + "geneId": 2789, + "geneName": "iodothyronine deiodinase 1", + "description": null, + "geneSymbol": "DIO1", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 1733, + "officialSymbol": "DIO1", + "officialFullName": "iodothyronine deiodinase 1", + "uniprotAccessionNumber": null + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfx27", + "url": "https://pubmed.ncbi.nlm.nih.gov/29228274/", + "pmid": 29228274, + "title": "Screening the ToxCast Phase 1 Chemical Library for Inhibition of Deiodinase Type 1 Activity", + "author": "Hornung MW, Korte JJ, Olker JH, Denny JS, Knutsen C, Hartig PC, Cardon MC, Degitz SJ", + "citation": "Hornung MW, Korte JJ, Olker JH, Denny JS, Knutsen C, Hartig PC, Cardon MC, Degitz SJ. Screening the ToxCast Phase 1 Chemical Library for Inhibition of Deiodinase Type 1 Activity. Toxicol Sci. 2018 Apr 1;162(2):570-581. doi: 10.1093/toxsci/kfx279. PMID: 29228274; PMCID: PMC6639810.", + "otherId": "0", + "citationId": 238, + "otherSource": "" + } + }, + { + "aeid": 2362, + "assayComponentEndpointName": "TOX21_PXR_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint TOX21_PXR_viability was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "46 uM rifampicin ", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2369, + "assayComponentName": "TOX21_PXR_viability", + "assayComponentDesc": "TOX21_PXR_viability is a component of the TOX21_PXR assay. This component measures cell viability using the CellTiter-Fluor assay system.", + "assayComponentTargetDesc": "The human pregnane X receptor (hPXR) regulates the expression of several drug metabolizing enzymes and induction of these proteins is a major mechanism for developing drug resistance in cancer. One such key enzyme catalyzing the drug metabolism is cytochrome P450 3A4 (CYP3A4). Changes in CYP3A4 expression affect drug metabolism, thereby reducing the therapeutic efficacy and altering toxicological response to a drug and which finally causes adverse drug interaction.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "living cells", + "biologicalProcessTarget": "cytotoxicity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Cell Titer Fluor assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Fluor reagent", + "technologicalTargetType": "cell morphology", + "technologicalTargetTypeSub": "cellular", + "aid": 670, + "assayName": "TOX21_PXR", + "assayDesc": "The TOX21_PXR is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing on a microplate: 1536-well plate. To screen Tox21 libraries for compounds that activate hPXR-mediated CYP3A4 gene expression, PXR-Luc HepG2 cells were used. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Fluor assay system in the same wells.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1016/j.bcp.2020.114368", + "url": "https://pubmed.ncbi.nlm.nih.gov/33333074/", + "pmid": 33333074, + "title": "Characterization of human pregnane X receptor activators identified from a screening of the Tox21 compound library", + "author": "Lynch C, Sakamuru S, Huang R, Niebler J, Ferguson SS, Xia M", + "citation": "Lynch C, Sakamuru S, Huang R, Niebler J, Ferguson SS, Xia M. Characterization of human pregnane X receptor activators identified from a screening of the Tox21 compound library. Biochem Pharmacol. 2021 Feb;184:114368. doi: 10.1016/j.bcp.2020.114368. Epub 2020 Dec 14. PMID: 33333074.", + "otherId": "0", + "citationId": 288, + "otherSource": "" + } + }, + { + "aeid": 2363, + "assayComponentEndpointName": "TOX21_PXR_agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PXR_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PXR_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to gene NR1I2. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor target family, where the subfamily is non-steroidal.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "46 uM rifampicin ", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2370, + "assayComponentName": "TOX21_PXR_agonist", + "assayComponentDesc": "TOX21_PXR_agonist is one of one assay component(s) measured or calculated from the TOX21_PXR assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "The human pregnane X receptor (hPXR) regulates the expression of several drug metabolizing enzymes and induction of these proteins is a major mechanism for developing drug resistance in cancer. One such key enzyme catalyzing the drug metabolism is cytochrome P450 3A4 (CYP3A4). Changes in CYP3A4 expression affect drug metabolism, thereby reducing the therapeutic efficacy and altering toxicological response to a drug and which finally causes adverse drug interaction. ", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 670, + "assayName": "TOX21_PXR", + "assayDesc": "The TOX21_PXR is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing on a microplate: 1536-well plate. To screen Tox21 libraries for compounds that activate hPXR-mediated CYP3A4 gene expression, PXR-Luc HepG2 cells were used. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Fluor assay system in the same wells.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 350, + "geneName": "nuclear receptor subfamily 1, group I, member 2", + "description": null, + "geneSymbol": "NR1I2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8856, + "officialSymbol": "NR1I2", + "officialFullName": "nuclear receptor subfamily 1, group I, member 2", + "uniprotAccessionNumber": "O75469" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.bcp.2020.114368", + "url": "https://pubmed.ncbi.nlm.nih.gov/33333074/", + "pmid": 33333074, + "title": "Characterization of human pregnane X receptor activators identified from a screening of the Tox21 compound library", + "author": "Lynch C, Sakamuru S, Huang R, Niebler J, Ferguson SS, Xia M", + "citation": "Lynch C, Sakamuru S, Huang R, Niebler J, Ferguson SS, Xia M. Characterization of human pregnane X receptor activators identified from a screening of the Tox21 compound library. Biochem Pharmacol. 2021 Feb;184:114368. doi: 10.1016/j.bcp.2020.114368. Epub 2020 Dec 14. PMID: 33333074.", + "otherId": "0", + "citationId": 288, + "otherSource": "" + } + }, + { + "aeid": 2364, + "assayComponentEndpointName": "TOX21_TRHR_HEK293_agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_TRHR_HEK293_Agonist used a type of biochemical reporter where gain-of-signal activity can be used to understand changes in the receptor activation. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is thyrotropin-releasing hormone receptor.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TRH", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "thyrotropin-releasing hormone receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2371, + "assayComponentName": "TOX21_TRHR_HEK293_agonist", + "assayComponentDesc": "TOX21_TRHR_HEK293_Agonist is one of 2 assay components measured in the TOX21_TRHR_HEK293 assay. It is designed to make measurements of intracellular calcium, a form of biochemical reporter, as detected with Fluorescence intensity signals by FDSS 7000EX kinetic plate reader technology.", + "assayComponentTargetDesc": "Thyrotropin-releasing hormone (TRH) receptor (TRHR) is a G-protein-coupled receptor which binds the tripeptide thyrotropin releasing hormone. TRHR is found in the brain and, when bound by TRH, acts (through phospholipase C) to increase intracellular inositol trisphosphate. It plays a crucial role in the anterior pituitary where it controls the synthesis and secretion of thyroid stimulating hormone and prolactin. Intracellular calcium is measured as an indicator of Gq-coupled human thyrotropin-releasing hormone receptor (TRHR) activation using fluorescent detection in a TRHR-Hek293 cell-based assay. Activation of this GPCR is indicated by increased intracellular calcium as measured in this cell-based fluorescent reporter assay.", + "parameterReadoutType": "single", + "assayDesignType": "biochemical reporter", + "assayDesignTypeSub": "intracellular calcium", + "biologicalProcessTarget": "receptor activation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "FDSS 7000EX kinetic plate reader ", + "keyAssayReagentType": "chemical", + "keyAssayReagent": "intracellular calcium", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "intracellular calcium", + "aid": 671, + "assayName": "TOX21_TRHR_HEK293", + "assayDesc": "TOX21_TRHR_HEK293 assay is a cell-based assay, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. It has the potential to screen G protein-coupled receptors. A compound/drug can either activate (agonist) or suppress (antagonist) GPCRs that can be monitored by levels of intracellular calcium. Using this assay, the Tox21 10K compound library was screened to identify potential TRHR agonists.", + "timepointHr": 20.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 7000, + "geneName": "thyrotropin releasing hormone receptor", + "description": null, + "geneSymbol": "TRHR", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 7201, + "officialSymbol": "TRHR", + "officialFullName": "thyrotropin releasing hormone receptor", + "uniprotAccessionNumber": null + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": null + }, + { + "aeid": 2365, + "assayComponentEndpointName": "TOX21_TRHR_HEK293_antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_TRHR_HEK293_Antagonist used a type of biochemical reporter where loss-of-signal activity can be used to understand changes in the receptor activation. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is thyrotropin-releasing hormone receptor.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM T293", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "thyrotropin-releasing hormone receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2372, + "assayComponentName": "TOX21_TRHR_HEK293_antagonist", + "assayComponentDesc": "TOX21_TRHR_HEK293_Antagonist is one of 2 assay components measured in the TOX21_TRHR_HEK293 assay. It is designed to make measurements of intracellular calcium, a form of biochemical reporter, as detected with Fluorescence intensity signals by FDSS 7000EX kinetic plate reader technology.", + "assayComponentTargetDesc": "Thyrotropin-releasing hormone (TRH) receptor (TRHR) is a G-protein-coupled receptor which binds the tripeptide thyrotropin releasing hormone. TRHR is found in the brain and, when bound by TRH, acts (through phospholipase C) to increase intracellular inositol trisphosphate. It plays a crucial role in the anterior pituitary where it controls the synthesis and secretion of thyroid stimulating hormone and prolactin. Inactivation of this GPCR is indicated by decreased intracellular calcium as measured in this cell-based fluorescent assay.", + "parameterReadoutType": "single", + "assayDesignType": "biochemical reporter", + "assayDesignTypeSub": "intracellular calcium", + "biologicalProcessTarget": "receptor activation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "FDSS 7000EX kinetic plate reader ", + "keyAssayReagentType": "chemical", + "keyAssayReagent": "intracellular calcium", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "intracellular calcium", + "aid": 671, + "assayName": "TOX21_TRHR_HEK293", + "assayDesc": "TOX21_TRHR_HEK293 assay is a cell-based assay, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. It has the potential to screen G protein-coupled receptors. A compound/drug can either activate (agonist) or suppress (antagonist) GPCRs that can be monitored by levels of intracellular calcium. Using this assay, the Tox21 10K compound library was screened to identify potential TRHR agonists.", + "timepointHr": 20.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 7000, + "geneName": "thyrotropin releasing hormone receptor", + "description": null, + "geneSymbol": "TRHR", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 7201, + "officialSymbol": "TRHR", + "officialFullName": "thyrotropin releasing hormone receptor", + "uniprotAccessionNumber": null + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": null + }, + { + "aeid": 2366, + "assayComponentEndpointName": "TOX21_CASP3_HEPG2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint TOX21_CASP3_HEPG2 was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. The TOX21_CASP3_HEPG2 assay is a homogeneous, luminescent assay that measures caspase-3 activity following compound treatment as an indicator of induction of apoptosis. Gain-of-signal activity can be used to understand changes in apoptosis. To generalize the intended target to other relatable targets, this assay endpoint is annotated to apoptosis, where the subfamily is caspase.", + "assayFunctionType": "inducer", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "apoptosis", + "intendedTargetFamilySub": "caspase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2373, + "assayComponentName": "TOX21_CASP3_HEPG2", + "assayComponentDesc": "TOX21_CASP3_HEPG2 is a component of the TOX21_CASP3_HEPG2 assay. This component measures caspase activity using the Caspase-Glo 3/7 assay system.", + "assayComponentTargetDesc": "Apoptosis is a process of programmed cell death and plays a central role in the development of multicellular organisms. It is a highly regulated process and induces cell death by activating caspases, which are the members of cysteine aspartic acid-specific protease (caspase) family. Caspases involved in apoptosis are classified by their mechanism of action as initiator caspases (caspase-2, -8, -9 and -10) and executioner caspases (caspase-3, -6, and -7). Inhibition of apoptosis results in number of cancers, autoimmune diseases, inflammatory diseases and viral infection.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "caspase activity", + "biologicalProcessTarget": "apoptosis", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "Caspase-Glo 3/7", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Caspase-Glo 3/7 reagent", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 672, + "assayName": "TOX21_CASP3_HEPG2", + "assayDesc": "The TOX21_CASP3_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 16 hours after chemical dosing on a microplate: 1536-well plate. To identify small molecule compounds that induce apoptosis, a homogeneous, luminescent Caspase-Glo 3/7 assay was used. HepG2 cells were used to screen Tox21 libraries for identifying caspase-3/7 activity inducers. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Fluor assay system in the same wells.", + "timepointHr": 16.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 41, + "geneName": "caspase 3, apoptosis-related cysteine peptidase", + "description": null, + "geneSymbol": "CASP3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 836, + "officialSymbol": "CASP3", + "officialFullName": "caspase 3, apoptosis-related cysteine peptidase", + "uniprotAccessionNumber": "P42574" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1373, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_YSE", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_YSE was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_YSE, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 940, + "assayComponentName": "Tanguay_ZF_120hpf_YSE", + "assayComponentDesc": "Tanguay_ZF_120hpf_YSE is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_YSE assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "extraembryonic membrane development", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1374, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_AXIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_AXIS was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_AXIS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 941, + "assayComponentName": "Tanguay_ZF_120hpf_AXIS", + "assayComponentDesc": "Tanguay_ZF_120hpf_AXIS is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_AXIS assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "body axis morphogenesis", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1375, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_EYE", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_EYE was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_EYE, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 942, + "assayComponentName": "Tanguay_ZF_120hpf_EYE", + "assayComponentDesc": "Tanguay_ZF_120hpf_EYE is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_EYE assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "embryonic eye development", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1376, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_SNOU", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_SNOU was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_SNOU, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 943, + "assayComponentName": "Tanguay_ZF_120hpf_SNOU", + "assayComponentDesc": "Tanguay_ZF_120hpf_SNOU is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_SNOU assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "embryonic snout morphogenesis", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1377, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_JAW", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_JAW was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_JAW, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 944, + "assayComponentName": "Tanguay_ZF_120hpf_JAW", + "assayComponentDesc": "Tanguay_ZF_120hpf_JAW is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_JAW assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "embryonic jaw development", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1378, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_OTIC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_OTIC was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_OTIC, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 945, + "assayComponentName": "Tanguay_ZF_120hpf_OTIC", + "assayComponentDesc": "Tanguay_ZF_120hpf_OTIC is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_OTIC assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "otic vesicle morphogenesis", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1379, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_PE", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_PE was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_PE, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 946, + "assayComponentName": "Tanguay_ZF_120hpf_PE", + "assayComponentDesc": "Tanguay_ZF_120hpf_PE is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_PE assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "embryonic morphogenesis", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1380, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_BRAI", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_BRAI was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_BRAI, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 947, + "assayComponentName": "Tanguay_ZF_120hpf_BRAI", + "assayComponentDesc": "Tanguay_ZF_120hpf_BRAI is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_BRAI assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "brain morphogenesis", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1381, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_SOMI", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_SOMI was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_SOMI, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 948, + "assayComponentName": "Tanguay_ZF_120hpf_SOMI", + "assayComponentDesc": "Tanguay_ZF_120hpf_SOMI is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_SOMI assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "somitogenesis", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1382, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_PFIN", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_PFIN was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_PFIN, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 949, + "assayComponentName": "Tanguay_ZF_120hpf_PFIN", + "assayComponentDesc": "Tanguay_ZF_120hpf_PFIN is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_PFIN assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "pectoral fin morphogenesis", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1383, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_CFIN", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_CFIN was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_CFIN, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 950, + "assayComponentName": "Tanguay_ZF_120hpf_CFIN", + "assayComponentDesc": "Tanguay_ZF_120hpf_CFIN is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_CFIN assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "caudal fin morphogenesis", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1384, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_PIG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_PIG was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_PIG, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 951, + "assayComponentName": "Tanguay_ZF_120hpf_PIG", + "assayComponentDesc": "Tanguay_ZF_120hpf_PIG is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_PIG assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "embryonic pigmentation", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1385, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_CIRC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_CIRC was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_CIRC, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 952, + "assayComponentName": "Tanguay_ZF_120hpf_CIRC", + "assayComponentDesc": "Tanguay_ZF_120hpf_CIRC is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_CIRC assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "angiogenesis", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1386, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_TRUN", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_TRUN was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_TRUN, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 953, + "assayComponentName": "Tanguay_ZF_120hpf_TRUN", + "assayComponentDesc": "Tanguay_ZF_120hpf_TRUN is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_TRUN assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "embryonic morphogenesis", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1387, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_SWIM", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_SWIM was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_SWIM, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 954, + "assayComponentName": "Tanguay_ZF_120hpf_SWIM", + "assayComponentDesc": "Tanguay_ZF_120hpf_SWIM is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_SWIM assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "swim bladder morphogenesis", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1388, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_NC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_NC was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_NC, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 955, + "assayComponentName": "Tanguay_ZF_120hpf_NC", + "assayComponentDesc": "Tanguay_ZF_120hpf_NC is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_NC assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "embryonic notochord morphogenesis", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1389, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_TR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_TR was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_TR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 956, + "assayComponentName": "Tanguay_ZF_120hpf_TR", + "assayComponentDesc": "Tanguay_ZF_120hpf_TR is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_TR assay. It is designed to make measurements of morphology as detected with brightfield microscopy of developing zebrafish embryos.", + "assayComponentTargetDesc": "Morphology is measured by light microscopic examination of developing zebrafish embryos.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "embryonic functional response", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1390, + "assayComponentEndpointName": "LTEA_HepaRG_SLC22A6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_SLC22A6 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_SLC22A6, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is organic anion transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "organic anion transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 957, + "assayComponentName": "LTEA_HepaRG_SLC22A6", + "assayComponentDesc": "LTEA_HepaRG_SLC22A6 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated transport.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 353, + "geneName": "solute carrier family 22 (organic anion transporter), member 6", + "description": null, + "geneSymbol": "SLC22A6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9356, + "officialSymbol": "SLC22A6", + "officialFullName": "solute carrier family 22 (organic anion transporter), member 6", + "uniprotAccessionNumber": "Q4U2R8" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1392, + "assayComponentEndpointName": "LTEA_HepaRG_KLK3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_KLK3 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_KLK3, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is Cellular remodeling.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "Cellular remodeling", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 958, + "assayComponentName": "LTEA_HepaRG_KLK3", + "assayComponentDesc": "LTEA_HepaRG_KLK3 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cellular remodeling.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 25, + "geneName": "kallikrein-related peptidase 3", + "description": null, + "geneSymbol": "KLK3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 354, + "officialSymbol": "KLK3", + "officialFullName": "kallikrein-related peptidase 3", + "uniprotAccessionNumber": "P07288" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1394, + "assayComponentEndpointName": "LTEA_HepaRG_SLC10A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_SLC10A1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_SLC10A1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is sodium/bile acid cotransporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "sodium/bile acid cotransporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 959, + "assayComponentName": "LTEA_HepaRG_SLC10A1", + "assayComponentDesc": "LTEA_HepaRG_SLC10A1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated transport.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 299, + "geneName": "solute carrier family 10 (sodium/bile acid cotransporter), member 1", + "description": null, + "geneSymbol": "SLC10A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6554, + "officialSymbol": "SLC10A1", + "officialFullName": "solute carrier family 10 (sodium/bile acid cotransporter), member 1", + "uniprotAccessionNumber": "Q14973" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1396, + "assayComponentEndpointName": "LTEA_HepaRG_MMP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_MMP1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_MMP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metalloproteinase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 960, + "assayComponentName": "LTEA_HepaRG_MMP1", + "assayComponentDesc": "LTEA_HepaRG_MMP1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Fibrosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 203, + "geneName": "matrix metallopeptidase 1 (interstitial collagenase)", + "description": null, + "geneSymbol": "MMP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4312, + "officialSymbol": "MMP1", + "officialFullName": "matrix metallopeptidase 1 (interstitial collagenase)", + "uniprotAccessionNumber": "P03956" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1398, + "assayComponentEndpointName": "LTEA_HepaRG_CYP24A1_1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP24A1_1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP24A1_1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 961, + "assayComponentName": "LTEA_HepaRG_CYP24A1_1", + "assayComponentDesc": "LTEA_HepaRG_CYP24A1_1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 95, + "geneName": "cytochrome P450, family 24, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP24A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1591, + "officialSymbol": "CYP24A1", + "officialFullName": "cytochrome P450, family 24, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "Q07973" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1507, + "assayComponentEndpointName": "CCTE_Padilla_ZF_144hpf_TERATOSCORE", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Padilla_ZF_144hpf_TERATOSCORE was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Padilla_ZF_144hpf_TERATOSCORE, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defect as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the malformation intended target family, where the subfamily is total.", + "assayFunctionType": "developmental defect", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "total", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 962, + "assayComponentName": "CCTE_Padilla_ZF_144hpf_TERATOSCORE", + "assayComponentDesc": "CCTE_Padilla_ZF_144hpf_TERATOSCORE is one of one assay component(s) measured or calculated from the CCTE_Padilla_ZF_144hpf assay. It is designed to make measurements of developmental malformations and mortality as detected with brightfield microscopy.", + "assayComponentTargetDesc": "Individual embryos were examined daily for malformations, failure to hatch and mortality. Results were scored by customized rubric and a composite score derived.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "embryo development", + "biologicalProcessTarget": "regulation of development", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "physical feature", + "aid": 410, + "assayName": "CCTE_Padilla_ZF_144hpf", + "assayDesc": "Zebrafish embryos were exposed to chemicals starting 6 hr post-fertilization for 5 days in 96-well plates. Developing larvae were examined microscopically daily for malformation and mortality. ", + "timepointHr": 144.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.4, + "asid": 12, + "assaySourceName": "CCTE_PADILLA", + "assaySourceLongName": "CCTE Padilla Lab", + "assaySourceDesc": "The Padilla laboratory at the EPA Center for Computational Toxicology focuses on the development and screening of zebrafish assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2011.10.018", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/22182468", + "pmid": 22182468, + "title": "Zebrafish developmental screening of the ToxCast™ Phase I chemical library", + "author": "Padilla S, Corum D, Padnos B, Hunter DL, Beam A, Houck KA, Sipes N, Kleinstreuer N, Knudsen T, Dix DJ, Reif DM", + "citation": "Padilla S, Corum D, Padnos B, Hunter DL, Beam A, Houck KA, Sipes N, Kleinstreuer N, Knudsen T, Dix DJ, Reif DM. Zebrafish developmental screening of the ToxCast™ Phase I chemical library. Reprod Toxicol. 2012 Apr;33(2):174-87. doi: 10.1016/j.reprotox.2011.10.018. Epub 2011 Dec 9. PubMed PMID: 22182468.", + "otherId": "0", + "citationId": 217, + "otherSource": "" + } + }, + { + "aeid": 2367, + "assayComponentEndpointName": "TOX21_CASP3_HEPG2_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint TOX21_CASP3_HEPG2_viability uses a type of viability reporter where loss-of-signal activity can be used to understand changes in viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2374, + "assayComponentName": "TOX21_CASP3_HEPG2_viability", + "assayComponentDesc": "TOX21_CASP3_HEPG2_viability is a component of the TOX21_CASP3_HEPG2 assay. This component measures cell viability using the CellTiter-Fluor assay system.", + "assayComponentTargetDesc": "Apoptosis is a process of programmed cell death and plays a central role in the development of multicellular organisms. It is a highly regulated process and induces cell death by activating caspases, which are the members of cysteine aspartic acid-specific protease (caspase) family. Caspases involved in apoptosis are classified by their mechanism of action as initiator caspases (caspase-2, -8, -9 and -10) and executioner caspases (caspase-3, -6, and -7). Inhibition of apoptosis results in number of cancers, autoimmune diseases, inflammatory diseases and viral infection. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "living cells", + "biologicalProcessTarget": "cytotoxicity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Cell Titer Fluor assay ", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Fluor reagent", + "technologicalTargetType": "cell morphology", + "technologicalTargetTypeSub": "cellular", + "aid": 672, + "assayName": "TOX21_CASP3_HEPG2", + "assayDesc": "The TOX21_CASP3_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 16 hours after chemical dosing on a microplate: 1536-well plate. To identify small molecule compounds that induce apoptosis, a homogeneous, luminescent Caspase-Glo 3/7 assay was used. HepG2 cells were used to screen Tox21 libraries for identifying caspase-3/7 activity inducers. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Fluor assay system in the same wells.", + "timepointHr": 16.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2368, + "assayComponentEndpointName": "TOX21_CASP3_CHO", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint TOX21_CASP3_CHO was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. The TOX21_CASP3_CHO assay is a homogeneous, luminescent assay that measures caspase-3 activity following chemical treatment as an indicator of induction of apoptosis. Gain-of-signal activity can be used to understand changes in apoptosis. To generalize the intended target to other relatable targets, this assay endpoint is annotated to apoptosis, where the subfamily is caspase.", + "assayFunctionType": "inducer", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "apoptosis", + "intendedTargetFamilySub": "caspase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2375, + "assayComponentName": "TOX21_CASP3_CHO", + "assayComponentDesc": "TOX21_CASP3_CHO is a component of the TOX21_CASP3_CHO assay. This component measures caspase activity using the Caspase-Glo 3/7 assay system.", + "assayComponentTargetDesc": "Apoptosis is a process of programmed cell death and plays a central role in the development of multicellular organisms. It is a highly regulated process and induces cell death by activating caspases, which are the members of cysteine aspartic acid-specific protease (caspase) family. Caspases involved in apoptosis are classified by their mechanism of action as initiator caspases (caspase-2, -8, -9 and -10) and executioner caspases (caspase-3, -6, and -7). Inhibition of apoptosis results in number of cancers, autoimmune diseases, inflammatory diseases and viral infection.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "caspase activity", + "biologicalProcessTarget": "apoptosis", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "Caspase-Glo 3/7", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Caspase-Glo 3/7 reagent", + "technologicalTargetType": "chemical ", + "technologicalTargetTypeSub": "ATP", + "aid": 678, + "assayName": "TOX21_CASP3_CHO", + "assayDesc": "The TOX21_CASP3_CHO is a cell-based, single-readout assay that uses CHO-K1, a hamster ovary cell line, with measurements taken at 16 hours after chemical dosing on a microplate: 1536-well plate. To identify small molecule compounds that induce apoptosis, a homogeneous, luminescent Caspase-Glo 3/7 assay was used. Wild type CHO-K1 cells were used to screen Tox21 libraries for identifying caspase-3/7 activity inducers. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Fluor assay system in the same wells.", + "timepointHr": 16.0, + "organismId": 10029, + "organism": "chinese hamster", + "tissue": "ovary", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "CHO-K1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 41, + "geneName": "caspase 3, apoptosis-related cysteine peptidase", + "description": null, + "geneSymbol": "CASP3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 836, + "officialSymbol": "CASP3", + "officialFullName": "caspase 3, apoptosis-related cysteine peptidase", + "uniprotAccessionNumber": "P42574" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2369, + "assayComponentEndpointName": "TOX21_CASP3_CHO_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint TOX21_CASP3_CHO_viability uses a type of viability reporter where loss-of-signal activity can be used to understand changes in viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2376, + "assayComponentName": "TOX21_CASP3_CHO_viability", + "assayComponentDesc": "TOX21_CASP3_CHO_viability is a component of the TOX21_CASP3_CHO assay. This component measures cell viability using the CellTiter-Fluor assay system.", + "assayComponentTargetDesc": "Apoptosis is a process of programmed cell death and plays a central role in the development of multicellular organisms. It is a highly regulated process and induces cell death by activating caspases, which are the members of cysteine aspartic acid-specific protease (caspase) family. Caspases involved in apoptosis are classified by their mechanism of action as initiator caspases (caspase-2, -8, -9 and -10) and executioner caspases (caspase-3, -6, and -7). Inhibition of apoptosis results in number of cancers, autoimmune diseases, inflammatory diseases and viral infection.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "living cells", + "biologicalProcessTarget": "cytotoxicity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Cell Titer Fluor assay ", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Fluor reagent", + "technologicalTargetType": "cell morphology", + "technologicalTargetTypeSub": "cellular", + "aid": 678, + "assayName": "TOX21_CASP3_CHO", + "assayDesc": "The TOX21_CASP3_CHO is a cell-based, single-readout assay that uses CHO-K1, a hamster ovary cell line, with measurements taken at 16 hours after chemical dosing on a microplate: 1536-well plate. To identify small molecule compounds that induce apoptosis, a homogeneous, luminescent Caspase-Glo 3/7 assay was used. Wild type CHO-K1 cells were used to screen Tox21 libraries for identifying caspase-3/7 activity inducers. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Fluor assay system in the same wells.", + "timepointHr": 16.0, + "organismId": 10029, + "organism": "chinese hamster", + "tissue": "ovary", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "CHO-K1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 2370, + "assayComponentEndpointName": "TOX21_SBE_BLA_Antagonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_SBE_BLA_Antagonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_SBE_BLA_Antagonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TGFB1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2377, + "assayComponentName": "TOX21_SBE_BLA_Antagonist_ch1", + "assayComponentDesc": "TOX21_SBE_BLA_Antagonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Transforming growth factor beta (TGF-beta) superfamily consists of a large number of structurally related dimeric proteins that act as hormones or local mediators in regulating a wide range of biological functions. This superfamily includes TGF-betas themselves, the bone morphogenetic proteins (BMPs) and the activins. These ligands induce oligomerization of serine/threonine receptor kinases and phosphorylate the cytoplasmic signaling molecules of Smad protein family.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 679, + "assayName": "TOX21_SBE_BLA_Antagonist", + "assayDesc": "The TOX21_SBE_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T , a human kidney cell line, with measurements taken at 5 hours after chemical dosing on a microplate: 1536-well plate. This cell line contains a beta-lactamase reporter gene under control of the Smad binding element (SBE) stably integrated into HEK 293T cells. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Glo assay system in the same wells.", + "timepointHr": 5.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00228", + "url": "https://pubmed.ncbi.nlm.nih.gov/31652400/", + "pmid": 31652400, + "title": "Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway", + "author": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M", + "citation": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M. Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway. Chem Res Toxicol. 2019 Dec 16;32(12):2433-2444. doi: 10.1021/acs.chemrestox.9b00228. Epub 2019 Nov 11. PMID: 31652400; PMCID: PMC7341485.", + "otherId": "0", + "citationId": 282, + "otherSource": "" + } + }, + { + "aeid": 2371, + "assayComponentEndpointName": "TOX21_SBE_BLA_Antagonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_SBE_BLA_Antagonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_SBE_BLA_Antagonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TGFB1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2378, + "assayComponentName": "TOX21_SBE_BLA_Antagonist_ch2", + "assayComponentDesc": "TOX21_SBE_BLA_Antagonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Transforming growth factor beta (TGF-beta) superfamily consists of a large number of structurally related dimeric proteins that act as hormones or local mediators in regulating a wide range of biological functions. This superfamily includes TGF-betas themselves, the bone morphogenetic proteins (BMPs) and the activins. These ligands induce oligomerization of serine/threonine receptor kinases and phosphorylate the cytoplasmic signaling molecules of Smad protein family.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 679, + "assayName": "TOX21_SBE_BLA_Antagonist", + "assayDesc": "The TOX21_SBE_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T , a human kidney cell line, with measurements taken at 5 hours after chemical dosing on a microplate: 1536-well plate. This cell line contains a beta-lactamase reporter gene under control of the Smad binding element (SBE) stably integrated into HEK 293T cells. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Glo assay system in the same wells.", + "timepointHr": 5.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00228", + "url": "https://pubmed.ncbi.nlm.nih.gov/31652400/", + "pmid": 31652400, + "title": "Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway", + "author": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M", + "citation": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M. Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway. Chem Res Toxicol. 2019 Dec 16;32(12):2433-2444. doi: 10.1021/acs.chemrestox.9b00228. Epub 2019 Nov 11. PMID: 31652400; PMCID: PMC7341485.", + "otherId": "0", + "citationId": 282, + "otherSource": "" + } + }, + { + "aeid": 2372, + "assayComponentEndpointName": "TOX21_SBE_BLA_Antagonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_SBE_BLA_Antagonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_SBE_BLA_Antagonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TGFB1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the growth factor receptor intended target family, where subfamily is transforming growth factor beta.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "growth factor receptor", + "intendedTargetFamilySub": "transforming growth factor beta", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2379, + "assayComponentName": "TOX21_SBE_BLA_Antagonist_ratio", + "assayComponentDesc": "TOX21_SBE_BLA_Antagonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "Transforming growth factor beta (TGF-beta) superfamily consists of a large number of structurally related dimeric proteins that act as hormones or local mediators in regulating a wide range of biological functions. This superfamily includes TGF-betas themselves, the bone morphogenetic proteins (BMPs) and the activins. These ligands induce oligomerization of serine/threonine receptor kinases and phosphorylate the cytoplasmic signaling molecules of Smad protein family.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 679, + "assayName": "TOX21_SBE_BLA_Antagonist", + "assayDesc": "The TOX21_SBE_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T , a human kidney cell line, with measurements taken at 5 hours after chemical dosing on a microplate: 1536-well plate. This cell line contains a beta-lactamase reporter gene under control of the Smad binding element (SBE) stably integrated into HEK 293T cells. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Glo assay system in the same wells.", + "timepointHr": 5.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 196, + "geneName": "SMAD family member 1", + "description": null, + "geneSymbol": "SMAD1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4086, + "officialSymbol": "SMAD1", + "officialFullName": "SMAD family member 1", + "uniprotAccessionNumber": "Q15797" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00228", + "url": "https://pubmed.ncbi.nlm.nih.gov/31652400/", + "pmid": 31652400, + "title": "Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway", + "author": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M", + "citation": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M. Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway. Chem Res Toxicol. 2019 Dec 16;32(12):2433-2444. doi: 10.1021/acs.chemrestox.9b00228. Epub 2019 Nov 11. PMID: 31652400; PMCID: PMC7341485.", + "otherId": "0", + "citationId": 282, + "otherSource": "" + } + }, + { + "aeid": 2373, + "assayComponentEndpointName": "TOX21_SBE_BLA_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint TOX21_SBE_BLA_Antagonist_viability was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2380, + "assayComponentName": "TOX21_SBE_BLA_Antagonist_viability", + "assayComponentDesc": "TOX21_SBE_BLA_Antagonist_viability is a component of the TOX21_SBE_BLA_Antagonist assay. This component measures cell viability using the CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 679, + "assayName": "TOX21_SBE_BLA_Antagonist", + "assayDesc": "The TOX21_SBE_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T , a human kidney cell line, with measurements taken at 5 hours after chemical dosing on a microplate: 1536-well plate. This cell line contains a beta-lactamase reporter gene under control of the Smad binding element (SBE) stably integrated into HEK 293T cells. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Glo assay system in the same wells.", + "timepointHr": 5.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00228", + "url": "https://pubmed.ncbi.nlm.nih.gov/31652400/", + "pmid": 31652400, + "title": "Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway", + "author": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M", + "citation": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M. Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway. Chem Res Toxicol. 2019 Dec 16;32(12):2433-2444. doi: 10.1021/acs.chemrestox.9b00228. Epub 2019 Nov 11. PMID: 31652400; PMCID: PMC7341485.", + "otherId": "0", + "citationId": 282, + "otherSource": "" + } + }, + { + "aeid": 2374, + "assayComponentEndpointName": "TOX21_SBE_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_SBE_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_SBE_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TGFB1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TGFb", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2381, + "assayComponentName": "TOX21_SBE_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_SBE_BLA_Agonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Transforming growth factor beta (TGF-beta) superfamily consists of a large number of structurally related dimeric proteins that act as hormones or local mediators in regulating a wide range of biological functions. This superfamily includes TGF-betas themselves, the bone morphogenetic proteins (BMPs) and the activins. These ligands induce oligomerization of serine/threonine receptor kinases and phosphorylate the cytoplasmic signaling molecules of Smad protein family.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 680, + "assayName": "TOX21_SBE_BLA_Agonist", + "assayDesc": "The TOX21_SBE_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T , a human kidney cell line, with measurements taken at 5 hours after chemical dosing on a microplate: 1536-well plate. This cell line contains a beta-lactamase reporter gene under control of the Smad binding element (SBE) stably integrated into HEK 293T cells. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Glo assay system in the same wells.", + "timepointHr": 5.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00228", + "url": "https://pubmed.ncbi.nlm.nih.gov/31652400/", + "pmid": 31652400, + "title": "Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway", + "author": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M", + "citation": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M. Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway. Chem Res Toxicol. 2019 Dec 16;32(12):2433-2444. doi: 10.1021/acs.chemrestox.9b00228. Epub 2019 Nov 11. PMID: 31652400; PMCID: PMC7341485.", + "otherId": "0", + "citationId": 282, + "otherSource": "" + } + }, + { + "aeid": 2375, + "assayComponentEndpointName": "TOX21_SBE_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_SBE_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_RXR_SBE_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene TGFB1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TGFb", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2382, + "assayComponentName": "TOX21_SBE_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_SBE_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "Transforming growth factor beta (TGF-beta) superfamily consists of a large number of structurally related dimeric proteins that act as hormones or local mediators in regulating a wide range of biological functions. This superfamily includes TGF-betas themselves, the bone morphogenetic proteins (BMPs) and the activins. These ligands induce oligomerization of serine/threonine receptor kinases and phosphorylate the cytoplasmic signaling molecules of Smad protein family.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 680, + "assayName": "TOX21_SBE_BLA_Agonist", + "assayDesc": "The TOX21_SBE_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T , a human kidney cell line, with measurements taken at 5 hours after chemical dosing on a microplate: 1536-well plate. This cell line contains a beta-lactamase reporter gene under control of the Smad binding element (SBE) stably integrated into HEK 293T cells. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Glo assay system in the same wells.", + "timepointHr": 5.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00228", + "url": "https://pubmed.ncbi.nlm.nih.gov/31652400/", + "pmid": 31652400, + "title": "Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway", + "author": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M", + "citation": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M. Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway. Chem Res Toxicol. 2019 Dec 16;32(12):2433-2444. doi: 10.1021/acs.chemrestox.9b00228. Epub 2019 Nov 11. PMID: 31652400; PMCID: PMC7341485.", + "otherId": "0", + "citationId": 282, + "otherSource": "" + } + }, + { + "aeid": 2376, + "assayComponentEndpointName": "TOX21_SBE_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_SBE_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_SBE_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene TGFB1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the growth factor receptor intended target family, where subfamily is transforming growth factor beta.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TGFb", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "growth factor receptor", + "intendedTargetFamilySub": "transforming growth factor beta", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2383, + "assayComponentName": "TOX21_SBE_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_SBE_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "Transforming growth factor beta (TGF-beta) superfamily consists of a large number of structurally related dimeric proteins that act as hormones or local mediators in regulating a wide range of biological functions. This superfamily includes TGF-betas themselves, the bone morphogenetic proteins (BMPs) and the activins. These ligands induce oligomerization of serine/threonine receptor kinases and phosphorylate the cytoplasmic signaling molecules of Smad protein family.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 680, + "assayName": "TOX21_SBE_BLA_Agonist", + "assayDesc": "The TOX21_SBE_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T , a human kidney cell line, with measurements taken at 5 hours after chemical dosing on a microplate: 1536-well plate. This cell line contains a beta-lactamase reporter gene under control of the Smad binding element (SBE) stably integrated into HEK 293T cells. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Glo assay system in the same wells.", + "timepointHr": 5.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 196, + "geneName": "SMAD family member 1", + "description": null, + "geneSymbol": "SMAD1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4086, + "officialSymbol": "SMAD1", + "officialFullName": "SMAD family member 1", + "uniprotAccessionNumber": "Q15797" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00228", + "url": "https://pubmed.ncbi.nlm.nih.gov/31652400/", + "pmid": 31652400, + "title": "Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway", + "author": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M", + "citation": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M. Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway. Chem Res Toxicol. 2019 Dec 16;32(12):2433-2444. doi: 10.1021/acs.chemrestox.9b00228. Epub 2019 Nov 11. PMID: 31652400; PMCID: PMC7341485.", + "otherId": "0", + "citationId": 282, + "otherSource": "" + } + }, + { + "aeid": 2377, + "assayComponentEndpointName": "TOX21_SBE_BLA_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint TOX21_SBE_BLA_Agonist_viability was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2384, + "assayComponentName": "TOX21_SBE_BLA_Agonist_viability", + "assayComponentDesc": "TOX21_SBE_BLA_Agonist_viability is a component of the TOX21_SBE_BLA_Agonist assay. This component measures cell viability using CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 680, + "assayName": "TOX21_SBE_BLA_Agonist", + "assayDesc": "The TOX21_SBE_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T , a human kidney cell line, with measurements taken at 5 hours after chemical dosing on a microplate: 1536-well plate. This cell line contains a beta-lactamase reporter gene under control of the Smad binding element (SBE) stably integrated into HEK 293T cells. Cytotoxicity of the compounds was tested in parallel by measuring the cell viability using CellTiter-Glo assay system in the same wells.", + "timepointHr": 5.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00228", + "url": "https://pubmed.ncbi.nlm.nih.gov/31652400/", + "pmid": 31652400, + "title": "Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway", + "author": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M", + "citation": "Wei Z, Sakamuru S, Zhang L, Zhao J, Huang R, Kleinstreuer NC, Chen Y, Shu Y, Knudsen TB, Xia M. Identification and Profiling of Environmental Chemicals That Inhibit the TGF?/SMAD Signaling Pathway. Chem Res Toxicol. 2019 Dec 16;32(12):2433-2444. doi: 10.1021/acs.chemrestox.9b00228. Epub 2019 Nov 11. PMID: 31652400; PMCID: PMC7341485.", + "otherId": "0", + "citationId": 282, + "otherSource": "" + } + }, + { + "aeid": 2386, + "assayComponentEndpointName": "UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Antagonist was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Antagonist, was analyzed in the positive analysis fitting direction relative to DHT as the baseline of activity. \r\n\r\nUsing a type of binding reporter, measures of receptor for loss-of-signal activity can be used to understand the binding at the pathway-level as it relates to the gene AR.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "DMSO", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2393, + "assayComponentName": "UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Antagonist", + "assayComponentDesc": "UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Antagonist is one of four assay components measured from the UPITT_AR_TIF2_PPIB assay. It is designed to make measurements of red fluorescence localized in the nucleolar region of the cell nucleus as detected with high-content fluorescent imaging.", + "assayComponentTargetDesc": "Loss of DHT-induced red fluorescence in nucleolar region of the cell nucleus is consistent with antagonism of human androgen receptor activity [GeneSymbol: AR | GeneID: 367 |", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein-protein binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Optical microscopy: Fluorescence microscopy", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor binding", + "aid": 681, + "assayName": "UPITT_AR_TIF2_PPIB", + "assayDesc": "UPITT_AR_TIF2_PPIB is a cell-based, high-content imaging assay that uses U2OS, a human osteosarcoma cell line, expressing a human androgen receptor fused to red fluorescent protein and the coactivator TIF2 fused to green fluorescent protein. ", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "bone", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "U2OS", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 25, + "assaySourceName": "UPITT", + "assaySourceLongName": "University of Pittsburgh Johnston Lab", + "assaySourceDesc": "The Johnston Lab at the University of Pittsburgh ran androgen receptor nuclear translocation assays under a Material Transfer Agreement (MTA) for the ToxCast Phase 1, Phase 2, and E1K chemicals. ", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1016/j.yrtph.2020.104764", + "url": "https://pubmed.ncbi.nlm.nih.gov/32798611/", + "pmid": 32798611, + "title": "Selecting a minimal set of androgen receptor assays for screening chemicals", + "author": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N", + "citation": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N. Selecting a minimal set of androgen receptor assays for screening chemicals. Regul Toxicol Pharmacol. 2020 Nov;117:104764. doi: 10.1016/j.yrtph.2020.104764. Epub 2020 Aug 14. PMID: 32798611; PMCID: PMC8356084.", + "otherId": "0", + "citationId": 283, + "otherSource": "" + } + }, + { + "aeid": 2387, + "assayComponentEndpointName": "UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Agonist was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the baseline of activity. \r\n\r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as it relates to the gene AR.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "dihydroxytestosterone (DHT)", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2394, + "assayComponentName": "UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Agonist", + "assayComponentDesc": "UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Agonist is one of four assay components measured from the UPITT_AR_TIF2_PPIB assay. It is designed to make measurements of red fluorescence localized in the nucleolar region of the cell nucleus as detected with high-content fluorescent imaging.", + "assayComponentTargetDesc": "Increased red fluorescence in nucleolar region of the cell nucleus is consistent with agonism of human androgen receptor activity [GeneSymbol: AR | GeneID: 367 |", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein-protein binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Optical microscopy: Fluorescence microscopy", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor binding", + "aid": 681, + "assayName": "UPITT_AR_TIF2_PPIB", + "assayDesc": "UPITT_AR_TIF2_PPIB is a cell-based, high-content imaging assay that uses U2OS, a human osteosarcoma cell line, expressing a human androgen receptor fused to red fluorescent protein and the coactivator TIF2 fused to green fluorescent protein. ", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "bone", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "U2OS", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 25, + "assaySourceName": "UPITT", + "assaySourceLongName": "University of Pittsburgh Johnston Lab", + "assaySourceDesc": "The Johnston Lab at the University of Pittsburgh ran androgen receptor nuclear translocation assays under a Material Transfer Agreement (MTA) for the ToxCast Phase 1, Phase 2, and E1K chemicals. ", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1016/j.yrtph.2020.104764", + "url": "https://pubmed.ncbi.nlm.nih.gov/32798611/", + "pmid": 32798611, + "title": "Selecting a minimal set of androgen receptor assays for screening chemicals", + "author": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N", + "citation": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N. Selecting a minimal set of androgen receptor assays for screening chemicals. Regul Toxicol Pharmacol. 2020 Nov;117:104764. doi: 10.1016/j.yrtph.2020.104764. Epub 2020 Aug 14. PMID: 32798611; PMCID: PMC8356084.", + "otherId": "0", + "citationId": 283, + "otherSource": "" + } + }, + { + "aeid": 2390, + "assayComponentEndpointName": "UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Cytoplasm_Ratio_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Cytoplasm_Ratio_Antagonist was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Cytoplasm_Ratio_Antagonist, was analyzed in the positive analysis fitting direction relative to DHT as the baseline of activity. \r\n\r\nUsing a type of binding reporter, measures of receptor for loss-of-signal activity can be used to understand the binding at the pathway-level as it relates to the gene AR.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "DMSO", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2397, + "assayComponentName": "UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Cytoplasm_Ratio_Antagonist", + "assayComponentDesc": "UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Cytoplasm_Ratio_Antagonist is one of four assay components measured from the UPITT_AR_TIF2_PPIB assay. It is designed to make measurements of the ratio of red fluorescence localized in the nucleolar region of the cell nucleus to red fluorescence localized in the cytoplasm as detected with high-content fluorescent imaging.", + "assayComponentTargetDesc": "Decrease of the ratio of DHT-induced red fluorescence in nucleolar region of the cell nucleus to the red fluorescence localized in the cytoplasm is consistent with antagonism of human androgen receptor activity [GeneSymbol: AR | GeneID: 367 |", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein-protein binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Optical microscopy: Fluorescence microscopy", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor binding", + "aid": 681, + "assayName": "UPITT_AR_TIF2_PPIB", + "assayDesc": "UPITT_AR_TIF2_PPIB is a cell-based, high-content imaging assay that uses U2OS, a human osteosarcoma cell line, expressing a human androgen receptor fused to red fluorescent protein and the coactivator TIF2 fused to green fluorescent protein. ", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "bone", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "U2OS", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 25, + "assaySourceName": "UPITT", + "assaySourceLongName": "University of Pittsburgh Johnston Lab", + "assaySourceDesc": "The Johnston Lab at the University of Pittsburgh ran androgen receptor nuclear translocation assays under a Material Transfer Agreement (MTA) for the ToxCast Phase 1, Phase 2, and E1K chemicals. ", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.yrtph.2020.104764", + "url": "https://pubmed.ncbi.nlm.nih.gov/32798611/", + "pmid": 32798611, + "title": "Selecting a minimal set of androgen receptor assays for screening chemicals", + "author": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N", + "citation": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N. Selecting a minimal set of androgen receptor assays for screening chemicals. Regul Toxicol Pharmacol. 2020 Nov;117:104764. doi: 10.1016/j.yrtph.2020.104764. Epub 2020 Aug 14. PMID: 32798611; PMCID: PMC8356084.", + "otherId": "0", + "citationId": 283, + "otherSource": "" + } + }, + { + "aeid": 2391, + "assayComponentEndpointName": "UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Cytoplasm_Ratio_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Cytoplasm_Ratio_Agonist was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Cytoplasm_Ratio_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the baseline of activity. \r\n\r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as it relates to the gene AR.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "dihydroxytestosterone (DHT)", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2398, + "assayComponentName": "UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Cytoplasm_Ratio_Agonist", + "assayComponentDesc": "UPITT_HCI_U2OS_AR_TIF2_Nucleoli_Cytoplasm_Ratio_Agonist is one of four assay components measured from the UPITT_AR_TIF2_PPIB assay. It is designed to make measurements of the ratio of red fluorescence localized in the nucleolar region of the cell nucleus to red fluorescence localized in the cytoplasm as detected with high-content fluorescent imaging.", + "assayComponentTargetDesc": "Increased ratio of DHT-induced red fluorescence in nucleolar region of the cell nucleus to the red fluorescence localized in the cytoplasm is consistent with agonism of human androgen receptor activity [GeneSymbol: AR | GeneID: 367 |", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein-protein binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Optical microscopy: Fluorescence microscopy", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor binding", + "aid": 681, + "assayName": "UPITT_AR_TIF2_PPIB", + "assayDesc": "UPITT_AR_TIF2_PPIB is a cell-based, high-content imaging assay that uses U2OS, a human osteosarcoma cell line, expressing a human androgen receptor fused to red fluorescent protein and the coactivator TIF2 fused to green fluorescent protein. ", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "bone", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "U2OS", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 25, + "assaySourceName": "UPITT", + "assaySourceLongName": "University of Pittsburgh Johnston Lab", + "assaySourceDesc": "The Johnston Lab at the University of Pittsburgh ran androgen receptor nuclear translocation assays under a Material Transfer Agreement (MTA) for the ToxCast Phase 1, Phase 2, and E1K chemicals. ", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.yrtph.2020.104764", + "url": "https://pubmed.ncbi.nlm.nih.gov/32798611/", + "pmid": 32798611, + "title": "Selecting a minimal set of androgen receptor assays for screening chemicals", + "author": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N", + "citation": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N. Selecting a minimal set of androgen receptor assays for screening chemicals. Regul Toxicol Pharmacol. 2020 Nov;117:104764. doi: 10.1016/j.yrtph.2020.104764. Epub 2020 Aug 14. PMID: 32798611; PMCID: PMC8356084.", + "otherId": "0", + "citationId": 283, + "otherSource": "" + } + }, + { + "aeid": 2442, + "assayComponentEndpointName": "CCTE_Simmons_MITO_basal_resp_rate", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Simmons_MITO_basal_resp_rate was analyzed at the endpoint, CCTE_Simmons_MITO_basal_resp_rate_OCR, with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of respirometric reporter, measures of basal respiration for gain or loss-of-signal activity can be used to understand cellular oxygen consumption as it relates to cellular respiration. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the mitochondria intended target family, where the subfamily is respiration.", + "assayFunctionType": "cellular respiration", + "normalizedDataType": "fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Fenpyroximate", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "mitochondria", + "intendedTargetFamilySub": "respiration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2440, + "assayComponentName": "CCTE_Simmons_MITO_basal_resp_rate", + "assayComponentDesc": "CCTE_Simmons_MITO_basal_resp_rate is one of 4 assay components calculated from the CCTE_Simmons_MITO assay. It is designed to make measurements of basal respiration using a form of respirometric reporter, as detected with bioluminescence signals by Seahorse XF96 technology. ", + "assayComponentTargetDesc": "Basal respiration rate is caculated from the oxygen consumption rates at T6 (36 min) following test compound injection, at 18 min elapsed exposure.", + "parameterReadoutType": "single", + "assayDesignType": "respirometric reporter", + "assayDesignTypeSub": "basal respiration", + "biologicalProcessTarget": "cellular oxygen consumption", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "oxygen consumption rate", + "detectionTechnology": "Seahorse XF96", + "keyAssayReagentType": "fluorescent oxygen sensor", + "keyAssayReagent": "Seahorse assay cartridge", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "dissolved oxygen", + "aid": 682, + "assayName": "CCTE_Simmons_MITO", + "assayDesc": "CCTE_Simmons_MITO is cell-based, respirometric assay using HepG2 cells and a Seahorse XF Analyzer to measure oxygen consumption rates over four temporal phases spanning a total of 72 minutes: pre-injection (pre-treatment), basal (following test compound injection), maximal (following FCCP uncoupler injection), and inhibited (following rotenone/antimycin A injection)", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa059", + "url": "https://pubmed.ncbi.nlm.nih.gov/32374859/", + "pmid": 32374859, + "title": "Respirometric Screening and Characterization of Mitochondrial Toxicants Within the ToxCast Phase I and II Chemical Libraries", + "author": "Hallinger DR, Lindsay HB, Paul Friedman K, Suarez DA, Simmons SO", + "citation": "Hallinger DR, Lindsay HB, Paul Friedman K, Suarez DA, Simmons SO. Respirometric Screening and Characterization of Mitochondrial Toxicants Within the ToxCast Phase I and II Chemical Libraries. Toxicol Sci. 2020 Jul 1;176(1):175-192. doi: 10.1093/toxsci/kfaa059. PMID: 32374859.", + "otherId": "0", + "citationId": 235, + "otherSource": "" + } + }, + { + "aeid": 2444, + "assayComponentEndpointName": "CCTE_Simmons_MITO_max_resp_rate", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Simmons_MITO_max_resp_rate was analyzed at the endpoint, CCTE_Simmons_MITO_max_resp_rate_OCR, with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of respirometric reporter, measures of maximal respiration for gain or loss-of-signal activity can be used to understand cellular oxygen consumption as it relates to cellular respiration. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the mitochondria intended target family, where the subfamily is respiration.", + "assayFunctionType": "cellular respiration", + "normalizedDataType": "fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Fenpyroximate", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "mitochondria", + "intendedTargetFamilySub": "respiration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2441, + "assayComponentName": "CCTE_Simmons_MITO_max_resp_rate", + "assayComponentDesc": "CCTE_Simmons_MITO_max_resp_rate is one of 4 assay components calculated from the CCTE_Simmons_MITO assay. It is designed to make measurements of maximal respiration using a form of respirometric reporter, as detected with bioluminescence signals by Seahorse XF96 technology. ", + "assayComponentTargetDesc": "Maximal respiration is calculated as oxygen consumption rates at T9 (54 min)following test compound injection at T6 and FCCP (uncoupler reagent), at 36 min elapsed exposure.", + "parameterReadoutType": "single", + "assayDesignType": "respirometric reporter", + "assayDesignTypeSub": "maximal respiration", + "biologicalProcessTarget": "cellular oxygen consumption", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "oxygen consumption rate", + "detectionTechnology": "Seahorse XF96", + "keyAssayReagentType": "fluorescent oxygen sensor", + "keyAssayReagent": "Seahorse assay cartridge", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "dissolved oxygen", + "aid": 682, + "assayName": "CCTE_Simmons_MITO", + "assayDesc": "CCTE_Simmons_MITO is cell-based, respirometric assay using HepG2 cells and a Seahorse XF Analyzer to measure oxygen consumption rates over four temporal phases spanning a total of 72 minutes: pre-injection (pre-treatment), basal (following test compound injection), maximal (following FCCP uncoupler injection), and inhibited (following rotenone/antimycin A injection)", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa059", + "url": "https://pubmed.ncbi.nlm.nih.gov/32374859/", + "pmid": 32374859, + "title": "Respirometric Screening and Characterization of Mitochondrial Toxicants Within the ToxCast Phase I and II Chemical Libraries", + "author": "Hallinger DR, Lindsay HB, Paul Friedman K, Suarez DA, Simmons SO", + "citation": "Hallinger DR, Lindsay HB, Paul Friedman K, Suarez DA, Simmons SO. Respirometric Screening and Characterization of Mitochondrial Toxicants Within the ToxCast Phase I and II Chemical Libraries. Toxicol Sci. 2020 Jul 1;176(1):175-192. doi: 10.1093/toxsci/kfaa059. PMID: 32374859.", + "otherId": "0", + "citationId": 235, + "otherSource": "" + } + }, + { + "aeid": 2446, + "assayComponentEndpointName": "CCTE_Simmons_MITO_inhib_resp_rate", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Simmons_MITO_inhib_resp_rate was analyzed at the endpoint, CCTE_Simmons_MITO_inhib_resp_rate_OCR, with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of respirometric reporter, measures of inhibited respiration for gain or loss-of-signal activity can be used to understand cellular oxygen consumption as it relates to cellular respiration. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the mitochondria intended target family, where the subfamily is respiration.", + "assayFunctionType": "cellular respiration", + "normalizedDataType": "fold_induction", + "burstAssay": 0, + "keyPositiveControl": "none", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "mitochondria", + "intendedTargetFamilySub": "respiration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2442, + "assayComponentName": "CCTE_Simmons_MITO_inhib_resp_rate", + "assayComponentDesc": "CCTE_Simmons_MITO_inhib_resp_rate is one of 4 assay components calculated from the CCTE_Simmons_MITO assay. It is designed to make measurements of inhibited respiration using a form of respirometric reporter, as detected with bioluminescence signals by Seahorse XF96 technology. ", + "assayComponentTargetDesc": "Inhibited respiration is calculated from the oxygen consumption rates at T12 (54 min) following test compound injection at T6, uncoupling at T9, and rotenone/antimycin A (electron transport chain inhibitor reagents), at 54 min elapsed exposure.", + "parameterReadoutType": "single", + "assayDesignType": "respirometric reporter", + "assayDesignTypeSub": "inhibited respiration", + "biologicalProcessTarget": "cellular oxygen consumption", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "oxygen consumption rate", + "detectionTechnology": "Seahorse XF96", + "keyAssayReagentType": "fluorescent oxygen sensor", + "keyAssayReagent": "Seahorse assay cartridge", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "dissolved oxygen", + "aid": 682, + "assayName": "CCTE_Simmons_MITO", + "assayDesc": "CCTE_Simmons_MITO is cell-based, respirometric assay using HepG2 cells and a Seahorse XF Analyzer to measure oxygen consumption rates over four temporal phases spanning a total of 72 minutes: pre-injection (pre-treatment), basal (following test compound injection), maximal (following FCCP uncoupler injection), and inhibited (following rotenone/antimycin A injection)", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa059", + "url": "https://pubmed.ncbi.nlm.nih.gov/32374859/", + "pmid": 32374859, + "title": "Respirometric Screening and Characterization of Mitochondrial Toxicants Within the ToxCast Phase I and II Chemical Libraries", + "author": "Hallinger DR, Lindsay HB, Paul Friedman K, Suarez DA, Simmons SO", + "citation": "Hallinger DR, Lindsay HB, Paul Friedman K, Suarez DA, Simmons SO. Respirometric Screening and Characterization of Mitochondrial Toxicants Within the ToxCast Phase I and II Chemical Libraries. Toxicol Sci. 2020 Jul 1;176(1):175-192. doi: 10.1093/toxsci/kfaa059. PMID: 32374859.", + "otherId": "0", + "citationId": 235, + "otherSource": "" + } + }, + { + "aeid": 2450, + "assayComponentEndpointName": "CCTE_Simmons_MITO_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Simmons_MITO_viability was analyzed at the endpoint, CCTE_Simmons_MITO_viability, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, measures of ATP content for loss-of-signal activity can be used to understand the viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "blank wells", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2443, + "assayComponentName": "CCTE_Simmons_MITO_viability", + "assayComponentDesc": "CCTE_Simmons_MITO_viability is one of 4 assay components measured from the CCTE_Simmons_MITO assay. It is designed to make measurements of ATP content, a form of viability reporter, as detected with bioluminescence signals by Luciferase-coupled ATP quantitation technology. ", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 682, + "assayName": "CCTE_Simmons_MITO", + "assayDesc": "CCTE_Simmons_MITO is cell-based, respirometric assay using HepG2 cells and a Seahorse XF Analyzer to measure oxygen consumption rates over four temporal phases spanning a total of 72 minutes: pre-injection (pre-treatment), basal (following test compound injection), maximal (following FCCP uncoupler injection), and inhibited (following rotenone/antimycin A injection)", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa059", + "url": "https://pubmed.ncbi.nlm.nih.gov/32374859/", + "pmid": 32374859, + "title": "Respirometric Screening and Characterization of Mitochondrial Toxicants Within the ToxCast Phase I and II Chemical Libraries", + "author": "Hallinger DR, Lindsay HB, Paul Friedman K, Suarez DA, Simmons SO", + "citation": "Hallinger DR, Lindsay HB, Paul Friedman K, Suarez DA, Simmons SO. Respirometric Screening and Characterization of Mitochondrial Toxicants Within the ToxCast Phase I and II Chemical Libraries. Toxicol Sci. 2020 Jul 1;176(1):175-192. doi: 10.1093/toxsci/kfaa059. PMID: 32374859.", + "otherId": "0", + "citationId": 235, + "otherSource": "" + } + }, + { + "aeid": 2451, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Viability_MCF7", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Viability_MCF7 was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain-of-signal activity can be used to evaluate membrane integrity using propidium iodide dye exclusion to understand changes in cytotoxicity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM N6", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2445, + "assayComponentName": "CCTE_Harrill_HTTr_Viability_MCF7", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Viability assay. This was part of a full screening experiment. This is a cell-based assay that evaluates cell viability in MCF-7 cells cultured in DMEM + 10% fetal bovine serum. High content imaging is used to evaluate membrane integrity using propidium iodide dye exclusion. Measurements are taken at 6 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "propidium iodide is membrane impermeant and binds to DNA in dead/dying cells.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "membrane impermeable stain for DNA", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "propidium iodide", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "nuclear DNA", + "aid": 665, + "assayName": "CCTE_Harrill_HTTr_Viability", + "assayDesc": "This is a cell-based assay that evaluates cell viability using high content imaging to evaluate membrane integrity using propidium iodide dye exclusion in a 384 well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 1508, + "assayComponentEndpointName": "CCTE_Simmons_AUR_TPO", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Simmons_AUR_TPO was analyzed at the endpoint, CCTE_Simmons_AUR_TPO, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, the Amplex UltraRed assay, loss-of-signal activity can be used to understand decreased peroxidase activity in the presence of excess hydrogen peroxidase. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is peroxidase.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "methimazole (MMI)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "peroxidase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 963, + "assayComponentName": "CCTE_Simmons_AUR_TPO", + "assayComponentDesc": "CCTE_Simmons_AUR_TPO is the assay component measured from the CCTE_Simmons_AUR_TPO assay. It is designed to make measurements of thyroperoxidase (TPO) activity as detected with fluorescence intensity signals by Fluorescence using the Amplex UltraRed technology as a form of enzyme activity reporter.", + "assayComponentTargetDesc": "A well-characterized MIE for adverse thyroid-mediated outcomes is inhibition of TPO. TPO catalyzes iodine oxidation in the presence of hydrogen peroxide, regulates nonspecific iodination of tyrosyl residues of thyroglobulin to form TH precursors, monoiodotyrosine (MIT), and diiodotyrosine (DIT), and modulates coupling of these iodotyrosyl residues.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Amplex UltraRed", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 411, + "assayName": "CCTE_Simmons_AUR_TPO", + "assayDesc": "CCTE_Simmons_AUR_TPO is a biochemical, single-readout assay that uses microsomes from rat thyroid gland in a tissue-based cell-free assay.Measurements were taken 0.5 hour after chemical dosing in a 384-well plate.", + "timepointHr": 0.5, + "organismId": 10116, + "organism": "rat", + "tissue": "thyroid gland", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "rat thyroid gland", + "cellShortName": "", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": { + "geneId": 498, + "geneName": "thyroid peroxidase", + "description": null, + "geneSymbol": "Tpo", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 54314, + "officialSymbol": "Tpo", + "officialFullName": "thyroid peroxidase", + "uniprotAccessionNumber": "P14650" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1021/tx400310w", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24383450", + "pmid": 24383450, + "title": "Development of a thyroperoxidase inhibition assay for high-throughput screening", + "author": "Paul KB, Hedge JM, Rotroff DM, Hornung MW, Crofton KM, Simmons SO", + "citation": "Paul KB, Hedge JM, Rotroff DM, Hornung MW, Crofton KM, Simmons SO. Development of a thyroperoxidase inhibition assay for high-throughput screening. Chem Res Toxicol. 2014 Mar 17;27(3):387-99. doi: 10.1021/tx400310w. Epub 2014 Jan 14. PubMed PMID: 24383450.", + "otherId": "0", + "citationId": 218, + "otherSource": "" + } + }, + { + "aeid": 1509, + "assayComponentEndpointName": "CCTE_Simmons_CellTiterGLO_HEK293T", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Simmons_CellTiterGLO_HEK293T was analyzed at the endpoint, CCTE_Simmons_CellTiterGLO_HEK293T, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, measures of ATP content for loss-of-signal activity can be used to understand the viability. This assay was run in parallel with aeid 1508 as a means of indicating the range of chemical cytotoxicity or reactivity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "LUCINH1;LUCINH2", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 964, + "assayComponentName": "CCTE_Simmons_CellTiterGLO_HEK293T", + "assayComponentDesc": "CCTE_Simmons_CellTiterGLO_HEK293T is the assay component measured from the CCTE_Simmons_CellTiterGLO_HEK293T assay. It is designed to make measurements of ATP content, a form of viability reporter, as detected with bioluminescence signals by Luciferase-coupled ATP quantitation technology. This is a secondary cytotoxicity assay to CCTE_Simmons_AUR_TPO to estimate a cellular tolerance limit.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo Fluor] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo fluor", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 412, + "assayName": "CCTE_Simmons_CellTiterGLO_HEK293T", + "assayDesc": "CCTE_Simmons_CellTiterGLO_HEK293T is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1021/tx400310w", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24383450", + "pmid": 24383450, + "title": "Development of a thyroperoxidase inhibition assay for high-throughput screening", + "author": "Paul KB, Hedge JM, Rotroff DM, Hornung MW, Crofton KM, Simmons SO", + "citation": "Paul KB, Hedge JM, Rotroff DM, Hornung MW, Crofton KM, Simmons SO. Development of a thyroperoxidase inhibition assay for high-throughput screening. Chem Res Toxicol. 2014 Mar 17;27(3):387-99. doi: 10.1021/tx400310w. Epub 2014 Jan 14. PubMed PMID: 24383450.", + "otherId": "0", + "citationId": 218, + "otherSource": "" + } + }, + { + "aeid": 1611, + "assayComponentEndpointName": "CLD_ABCB1_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_ABCB1_6hr was analyzed at the endpoint, CLD_ABCB1_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ABCB1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 838, + "assayComponentName": "CLD_ABCB1_6hr", + "assayComponentDesc": "CLD_ABCB1_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "ABCB1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 236, + "geneName": "ATP-binding cassette, sub-family B (MDR/TAP), member 1", + "description": null, + "geneSymbol": "ABCB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5243, + "officialSymbol": "ABCB1", + "officialFullName": "ATP-binding cassette, sub-family B (MDR/TAP), member 1", + "uniprotAccessionNumber": "P08183" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1612, + "assayComponentEndpointName": "CLD_ABCB11_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_ABCB11_6hr was analyzed at the endpoint, CLD_ABCB11_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ABCB11. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 839, + "assayComponentName": "CLD_ABCB11_6hr", + "assayComponentDesc": "CLD_ABCB11_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "ABCB11 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 345, + "geneName": "ATP-binding cassette, sub-family B (MDR/TAP), member 11", + "description": null, + "geneSymbol": "ABCB11", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8647, + "officialSymbol": "ABCB11", + "officialFullName": "ATP-binding cassette, sub-family B (MDR/TAP), member 11", + "uniprotAccessionNumber": "O95342" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1613, + "assayComponentEndpointName": "CLD_ABCG2_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_ABCG2_6hr was analyzed at the endpoint, CLD_ABCG2_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ABCG2. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 840, + "assayComponentName": "CLD_ABCG2_6hr", + "assayComponentDesc": "CLD_ABCG2_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "ABCG2 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 354, + "geneName": "ATP-binding cassette, sub-family G (WHITE), member 2 (Junior blood group)", + "description": null, + "geneSymbol": "ABCG2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9429, + "officialSymbol": "ABCG2", + "officialFullName": "ATP-binding cassette, sub-family G (WHITE), member 2 (Junior blood group)", + "uniprotAccessionNumber": "Q9UNQ0" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1614, + "assayComponentEndpointName": "CLD_ACTIN_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_ACTIN_6hr was analyzed at the endpoint, CLD_ACTIN_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ACTA1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where subfamily is baseline control.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 841, + "assayComponentName": "CLD_ACTIN_6hr", + "assayComponentDesc": "CLD_ACTIN_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "ACTIN qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 7, + "geneName": "actin, beta", + "description": null, + "geneSymbol": "ACTB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 60, + "officialSymbol": "ACTB", + "officialFullName": "actin, beta", + "uniprotAccessionNumber": "P60709" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1615, + "assayComponentEndpointName": "CLD_CYP1A1_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP1A1_6hr was analyzed at the endpoint, CLD_CYP1A1_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP1A1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 842, + "assayComponentName": "CLD_CYP1A1_6hr", + "assayComponentDesc": "CLD_CYP1A1_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP1A1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 77, + "geneName": "cytochrome P450, family 1, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP1A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1543, + "officialSymbol": "CYP1A1", + "officialFullName": "cytochrome P450, family 1, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "P04798" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1616, + "assayComponentEndpointName": "CLD_CYP1A2_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP1A2_6hr was analyzed at the endpoint, CLD_CYP1A2_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP1A2. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 843, + "assayComponentName": "CLD_CYP1A2_6hr", + "assayComponentDesc": "CLD_CYP1A2_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP1A2 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 78, + "geneName": "cytochrome P450, family 1, subfamily A, polypeptide 2", + "description": null, + "geneSymbol": "CYP1A2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1544, + "officialSymbol": "CYP1A2", + "officialFullName": "cytochrome P450, family 1, subfamily A, polypeptide 2", + "uniprotAccessionNumber": "P05177" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1617, + "assayComponentEndpointName": "CLD_CYP2B6_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP2B6_6hr was analyzed at the endpoint, CLD_CYP2B6_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP2B6. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 844, + "assayComponentName": "CLD_CYP2B6_6hr", + "assayComponentDesc": "CLD_CYP2B6_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP2B6 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 82, + "geneName": "cytochrome P450, family 2, subfamily B, polypeptide 6", + "description": null, + "geneSymbol": "CYP2B6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1555, + "officialSymbol": "CYP2B6", + "officialFullName": "cytochrome P450, family 2, subfamily B, polypeptide 6", + "uniprotAccessionNumber": "P20813" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1618, + "assayComponentEndpointName": "CLD_CYP2C19_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP2C19_6hr was analyzed at the endpoint, CLD_CYP2C19_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP2C19. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 845, + "assayComponentName": "CLD_CYP2C19_6hr", + "assayComponentDesc": "CLD_CYP2C19_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP2C19 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 83, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "description": null, + "geneSymbol": "CYP2C19", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1557, + "officialSymbol": "CYP2C19", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "uniprotAccessionNumber": "P33261" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1619, + "assayComponentEndpointName": "CLD_CYP2C9_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP2C9_6hr was analyzed at the endpoint, CLD_CYP2C9_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP2C9. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 846, + "assayComponentName": "CLD_CYP2C9_6hr", + "assayComponentDesc": "CLD_CYP2C9_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP2C9 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 85, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 9", + "description": null, + "geneSymbol": "CYP2C9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1559, + "officialSymbol": "CYP2C9", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 9", + "uniprotAccessionNumber": "P11712" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1620, + "assayComponentEndpointName": "CLD_CYP3A4_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP3A4_6hr was analyzed at the endpoint, CLD_CYP3A4_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP3A4. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 847, + "assayComponentName": "CLD_CYP3A4_6hr", + "assayComponentDesc": "CLD_CYP3A4_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP3A4 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 90, + "geneName": "cytochrome P450, family 3, subfamily A, polypeptide 4", + "description": null, + "geneSymbol": "CYP3A4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1576, + "officialSymbol": "CYP3A4", + "officialFullName": "cytochrome P450, family 3, subfamily A, polypeptide 4", + "uniprotAccessionNumber": "P08684" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1621, + "assayComponentEndpointName": "CLD_GAPDH_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_GAPDH_6hr was analyzed at the endpoint, CLD_GAPDH_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene GAPDH. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where subfamily is baseline control.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 848, + "assayComponentName": "CLD_GAPDH_6hr", + "assayComponentDesc": "CLD_GAPDH_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "GAPDH qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 138, + "geneName": "glyceraldehyde-3-phosphate dehydrogenase", + "description": null, + "geneSymbol": "GAPDH", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2597, + "officialSymbol": "GAPDH", + "officialFullName": "glyceraldehyde-3-phosphate dehydrogenase", + "uniprotAccessionNumber": "P04406" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1622, + "assayComponentEndpointName": "CLD_GSTA2_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_GSTA2_6hr was analyzed at the endpoint, CLD_GSTA2_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene GSTA2. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where subfamily is alkyl and aryl transferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "alkyl and aryl transferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 849, + "assayComponentName": "CLD_GSTA2_6hr", + "assayComponentDesc": "CLD_GSTA2_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "GSTA2 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 147, + "geneName": "glutathione S-transferase alpha 2", + "description": null, + "geneSymbol": "GSTA2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2939, + "officialSymbol": "GSTA2", + "officialFullName": "glutathione S-transferase alpha 2", + "uniprotAccessionNumber": "P09210" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1623, + "assayComponentEndpointName": "CLD_HMGCS2_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_HMGCS2_6hr was analyzed at the endpoint, CLD_HMGCS2_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene HMGCS2. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the lyase intended target family, where subfamily is HMG-CoA synthase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "lyase", + "intendedTargetFamilySub": "HMG-CoA synthase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 850, + "assayComponentName": "CLD_HMGCS2_6hr", + "assayComponentDesc": "CLD_HMGCS2_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "HMGCS2 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 154, + "geneName": "3-hydroxy-3-methylglutaryl-CoA synthase 2 (mitochondrial)", + "description": null, + "geneSymbol": "HMGCS2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3158, + "officialSymbol": "HMGCS2", + "officialFullName": "3-hydroxy-3-methylglutaryl-CoA synthase 2 (mitochondrial)", + "uniprotAccessionNumber": "P54868" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1624, + "assayComponentEndpointName": "CLD_SLCO1B1_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_SLCO1B1_6hr was analyzed at the endpoint, CLD_SLCO1B1_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene SLCO1B1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where subfamily is organic anion transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "organic anion transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 851, + "assayComponentName": "CLD_SLCO1B1_6hr", + "assayComponentDesc": "CLD_SLCO1B1_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "SLCO1B1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 367, + "geneName": "solute carrier organic anion transporter family, member 1B1", + "description": null, + "geneSymbol": "SLCO1B1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10599, + "officialSymbol": "SLCO1B1", + "officialFullName": "solute carrier organic anion transporter family, member 1B1", + "uniprotAccessionNumber": "Q9Y6L6" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1625, + "assayComponentEndpointName": "CLD_SULT2A_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_SULT2A_6hr was analyzed at the endpoint, CLD_SULT2A_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene SULT2A1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where subfamily is sulfotransferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "sulfotransferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 852, + "assayComponentName": "CLD_SULT2A_6hr", + "assayComponentDesc": "CLD_SULT2A_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "SULT2A1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 307, + "geneName": "sulfotransferase family, cytosolic, 2A, dehydroepiandrosterone (DHEA)-preferring, member 1", + "description": null, + "geneSymbol": "SULT2A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6822, + "officialSymbol": "SULT2A1", + "officialFullName": "sulfotransferase family, cytosolic, 2A, dehydroepiandrosterone (DHEA)-preferring, member 1", + "uniprotAccessionNumber": "Q06520" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1626, + "assayComponentEndpointName": "CLD_UGT1A1_6hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_UGT1A1_6hr was analyzed at the endpoint, CLD_UGT1A1_6hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene UGT1A1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where subfamily is glucuronosyltransferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "glucuronosyltransferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 853, + "assayComponentName": "CLD_UGT1A1_6hr", + "assayComponentDesc": "CLD_UGT1A1_6hr is one of 16 assay component(s) measured or calculated from the CLD_6hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "UGT1A1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 399, + "assayName": "CLD_6hr", + "assayDesc": "CLD_6hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 6 hours after chemical dosing in a 96-well plate.", + "timepointHr": 6.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 430, + "geneName": "UDP glucuronosyltransferase 1 family, polypeptide A1", + "description": null, + "geneSymbol": "UGT1A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 54658, + "officialSymbol": "UGT1A1", + "officialFullName": "UDP glucuronosyltransferase 1 family, polypeptide A1", + "uniprotAccessionNumber": "P22309" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1627, + "assayComponentEndpointName": "CLD_ABCB1_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_ABCB1_24hr was analyzed at the endpoint, CLD_ABCB1_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ABCB1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 854, + "assayComponentName": "CLD_ABCB1_24hr", + "assayComponentDesc": "CLD_ABCB1_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "ABCB1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 236, + "geneName": "ATP-binding cassette, sub-family B (MDR/TAP), member 1", + "description": null, + "geneSymbol": "ABCB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5243, + "officialSymbol": "ABCB1", + "officialFullName": "ATP-binding cassette, sub-family B (MDR/TAP), member 1", + "uniprotAccessionNumber": "P08183" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1628, + "assayComponentEndpointName": "CLD_ABCB11_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_ABCB11_24hr was analyzed at the endpoint, CLD_ABCB11_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ABCB11. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 855, + "assayComponentName": "CLD_ABCB11_24hr", + "assayComponentDesc": "CLD_ABCB11_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "ABCB11 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 345, + "geneName": "ATP-binding cassette, sub-family B (MDR/TAP), member 11", + "description": null, + "geneSymbol": "ABCB11", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8647, + "officialSymbol": "ABCB11", + "officialFullName": "ATP-binding cassette, sub-family B (MDR/TAP), member 11", + "uniprotAccessionNumber": "O95342" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1629, + "assayComponentEndpointName": "CLD_ABCG2_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_ABCG2_24hr was analyzed at the endpoint, CLD_ABCG2_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ABCG2. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 856, + "assayComponentName": "CLD_ABCG2_24hr", + "assayComponentDesc": "CLD_ABCG2_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "ABCG2 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 354, + "geneName": "ATP-binding cassette, sub-family G (WHITE), member 2 (Junior blood group)", + "description": null, + "geneSymbol": "ABCG2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9429, + "officialSymbol": "ABCG2", + "officialFullName": "ATP-binding cassette, sub-family G (WHITE), member 2 (Junior blood group)", + "uniprotAccessionNumber": "Q9UNQ0" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1630, + "assayComponentEndpointName": "CLD_ACTIN_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_ACTIN_24hr was analyzed at the endpoint, CLD_ACTIN_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ACTA1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where subfamily is baseline control.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 857, + "assayComponentName": "CLD_ACTIN_24hr", + "assayComponentDesc": "CLD_ACTIN_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "ACTIN qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 7, + "geneName": "actin, beta", + "description": null, + "geneSymbol": "ACTB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 60, + "officialSymbol": "ACTB", + "officialFullName": "actin, beta", + "uniprotAccessionNumber": "P60709" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1631, + "assayComponentEndpointName": "CLD_CYP1A1_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP1A1_24hr was analyzed at the endpoint, CLD_CYP1A1_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP1A1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 858, + "assayComponentName": "CLD_CYP1A1_24hr", + "assayComponentDesc": "CLD_CYP1A1_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP1A1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 77, + "geneName": "cytochrome P450, family 1, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP1A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1543, + "officialSymbol": "CYP1A1", + "officialFullName": "cytochrome P450, family 1, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "P04798" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1632, + "assayComponentEndpointName": "CLD_CYP1A2_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP1A2_24hr was analyzed at the endpoint, CLD_CYP1A2_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP1A2. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 859, + "assayComponentName": "CLD_CYP1A2_24hr", + "assayComponentDesc": "CLD_CYP1A2_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP1A2 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 78, + "geneName": "cytochrome P450, family 1, subfamily A, polypeptide 2", + "description": null, + "geneSymbol": "CYP1A2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1544, + "officialSymbol": "CYP1A2", + "officialFullName": "cytochrome P450, family 1, subfamily A, polypeptide 2", + "uniprotAccessionNumber": "P05177" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1633, + "assayComponentEndpointName": "CLD_CYP2B6_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP2B6_24hr was analyzed at the endpoint, CLD_CYP2B6_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP2B6. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 860, + "assayComponentName": "CLD_CYP2B6_24hr", + "assayComponentDesc": "CLD_CYP2B6_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP2B6 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 82, + "geneName": "cytochrome P450, family 2, subfamily B, polypeptide 6", + "description": null, + "geneSymbol": "CYP2B6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1555, + "officialSymbol": "CYP2B6", + "officialFullName": "cytochrome P450, family 2, subfamily B, polypeptide 6", + "uniprotAccessionNumber": "P20813" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1634, + "assayComponentEndpointName": "CLD_CYP2C19_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP2C19_24hr was analyzed at the endpoint, CLD_CYP2C19_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP2C19. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 861, + "assayComponentName": "CLD_CYP2C19_24hr", + "assayComponentDesc": "CLD_CYP2C19_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP2C19 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 83, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "description": null, + "geneSymbol": "CYP2C19", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1557, + "officialSymbol": "CYP2C19", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "uniprotAccessionNumber": "P33261" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1635, + "assayComponentEndpointName": "CLD_CYP2C9_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP2C9_24hr was analyzed at the endpoint, CLD_CYP2C9_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP2C9. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 862, + "assayComponentName": "CLD_CYP2C9_24hr", + "assayComponentDesc": "CLD_CYP2C9_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP2C9 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 85, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 9", + "description": null, + "geneSymbol": "CYP2C9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1559, + "officialSymbol": "CYP2C9", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 9", + "uniprotAccessionNumber": "P11712" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1636, + "assayComponentEndpointName": "CLD_CYP3A4_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP3A4_24hr was analyzed at the endpoint, CLD_CYP3A4_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP3A4. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 863, + "assayComponentName": "CLD_CYP3A4_24hr", + "assayComponentDesc": "CLD_CYP3A4_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP3A4 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 90, + "geneName": "cytochrome P450, family 3, subfamily A, polypeptide 4", + "description": null, + "geneSymbol": "CYP3A4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1576, + "officialSymbol": "CYP3A4", + "officialFullName": "cytochrome P450, family 3, subfamily A, polypeptide 4", + "uniprotAccessionNumber": "P08684" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1637, + "assayComponentEndpointName": "CLD_GAPDH_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_GAPDH_24hr was analyzed at the endpoint, CLD_GAPDH_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene GAPDH. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where subfamily is baseline control.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 864, + "assayComponentName": "CLD_GAPDH_24hr", + "assayComponentDesc": "CLD_GAPDH_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "GAPDH qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 138, + "geneName": "glyceraldehyde-3-phosphate dehydrogenase", + "description": null, + "geneSymbol": "GAPDH", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2597, + "officialSymbol": "GAPDH", + "officialFullName": "glyceraldehyde-3-phosphate dehydrogenase", + "uniprotAccessionNumber": "P04406" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1638, + "assayComponentEndpointName": "CLD_GSTA2_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_GSTA2_24hr was analyzed at the endpoint, CLD_GSTA2_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene GSTA2. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where subfamily is alkyl and aryl transferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "alkyl and aryl transferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 865, + "assayComponentName": "CLD_GSTA2_24hr", + "assayComponentDesc": "CLD_GSTA2_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "GSTA2 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 147, + "geneName": "glutathione S-transferase alpha 2", + "description": null, + "geneSymbol": "GSTA2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2939, + "officialSymbol": "GSTA2", + "officialFullName": "glutathione S-transferase alpha 2", + "uniprotAccessionNumber": "P09210" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1639, + "assayComponentEndpointName": "CLD_HMGCS2_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_HMGCS2_24hr was analyzed at the endpoint, CLD_HMGCS2_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene HMGCS2. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the lyase intended target family, where subfamily is HMG-CoA synthase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "lyase", + "intendedTargetFamilySub": "HMG-CoA synthase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 866, + "assayComponentName": "CLD_HMGCS2_24hr", + "assayComponentDesc": "CLD_HMGCS2_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "HMGCS2 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 154, + "geneName": "3-hydroxy-3-methylglutaryl-CoA synthase 2 (mitochondrial)", + "description": null, + "geneSymbol": "HMGCS2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3158, + "officialSymbol": "HMGCS2", + "officialFullName": "3-hydroxy-3-methylglutaryl-CoA synthase 2 (mitochondrial)", + "uniprotAccessionNumber": "P54868" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1640, + "assayComponentEndpointName": "CLD_SLCO1B1_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_SLCO1B1_24hr was analyzed at the endpoint, CLD_SLCO1B1_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene SLCO1B1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where subfamily is organic anion transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "organic anion transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 867, + "assayComponentName": "CLD_SLCO1B1_24hr", + "assayComponentDesc": "CLD_SLCO1B1_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "SLCO1B1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 367, + "geneName": "solute carrier organic anion transporter family, member 1B1", + "description": null, + "geneSymbol": "SLCO1B1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10599, + "officialSymbol": "SLCO1B1", + "officialFullName": "solute carrier organic anion transporter family, member 1B1", + "uniprotAccessionNumber": "Q9Y6L6" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1641, + "assayComponentEndpointName": "CLD_SULT2A_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_SULT2A_24hr was analyzed at the endpoint, CLD_SULT2A_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene SULT2A1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where subfamily is sulfotransferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "sulfotransferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 868, + "assayComponentName": "CLD_SULT2A_24hr", + "assayComponentDesc": "CLD_SULT2A_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "SULT2A1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 307, + "geneName": "sulfotransferase family, cytosolic, 2A, dehydroepiandrosterone (DHEA)-preferring, member 1", + "description": null, + "geneSymbol": "SULT2A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6822, + "officialSymbol": "SULT2A1", + "officialFullName": "sulfotransferase family, cytosolic, 2A, dehydroepiandrosterone (DHEA)-preferring, member 1", + "uniprotAccessionNumber": "Q06520" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1642, + "assayComponentEndpointName": "CLD_UGT1A1_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_UGT1A1_24hr was analyzed at the endpoint, CLD_UGT1A1_24hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene UGT1A1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where subfamily is glucuronosyltransferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "glucuronosyltransferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 869, + "assayComponentName": "CLD_UGT1A1_24hr", + "assayComponentDesc": "CLD_UGT1A1_24hr is one of 16 assay component(s) measured or calculated from the CLD_24hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "UGT1A1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 400, + "assayName": "CLD_24hr", + "assayDesc": "CLD_24hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 430, + "geneName": "UDP glucuronosyltransferase 1 family, polypeptide A1", + "description": null, + "geneSymbol": "UGT1A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 54658, + "officialSymbol": "UGT1A1", + "officialFullName": "UDP glucuronosyltransferase 1 family, polypeptide A1", + "uniprotAccessionNumber": "P22309" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1643, + "assayComponentEndpointName": "CLD_ABCB1_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_ABCB1_48hr was analyzed at the endpoint, CLD_ABCB1_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ABCB1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 870, + "assayComponentName": "CLD_ABCB1_48hr", + "assayComponentDesc": "CLD_ABCB1_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "ABCB1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 236, + "geneName": "ATP-binding cassette, sub-family B (MDR/TAP), member 1", + "description": null, + "geneSymbol": "ABCB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5243, + "officialSymbol": "ABCB1", + "officialFullName": "ATP-binding cassette, sub-family B (MDR/TAP), member 1", + "uniprotAccessionNumber": "P08183" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1644, + "assayComponentEndpointName": "CLD_ABCB11_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_ABCB11_48hr was analyzed at the endpoint, CLD_ABCB11_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ABCB11. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 871, + "assayComponentName": "CLD_ABCB11_48hr", + "assayComponentDesc": "CLD_ABCB11_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "ABCB11 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 345, + "geneName": "ATP-binding cassette, sub-family B (MDR/TAP), member 11", + "description": null, + "geneSymbol": "ABCB11", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8647, + "officialSymbol": "ABCB11", + "officialFullName": "ATP-binding cassette, sub-family B (MDR/TAP), member 11", + "uniprotAccessionNumber": "O95342" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1645, + "assayComponentEndpointName": "CLD_ABCG2_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_ABCG2_48hr was analyzed at the endpoint, CLD_ABCG2_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ABCG2. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 872, + "assayComponentName": "CLD_ABCG2_48hr", + "assayComponentDesc": "CLD_ABCG2_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "ABCG2 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 354, + "geneName": "ATP-binding cassette, sub-family G (WHITE), member 2 (Junior blood group)", + "description": null, + "geneSymbol": "ABCG2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9429, + "officialSymbol": "ABCG2", + "officialFullName": "ATP-binding cassette, sub-family G (WHITE), member 2 (Junior blood group)", + "uniprotAccessionNumber": "Q9UNQ0" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1646, + "assayComponentEndpointName": "CLD_ACTIN_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_ACTIN_48hr was analyzed at the endpoint, CLD_ACTIN_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ACTA1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where subfamily is baseline control.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 873, + "assayComponentName": "CLD_ACTIN_48hr", + "assayComponentDesc": "CLD_ACTIN_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "ACTIN qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 7, + "geneName": "actin, beta", + "description": null, + "geneSymbol": "ACTB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 60, + "officialSymbol": "ACTB", + "officialFullName": "actin, beta", + "uniprotAccessionNumber": "P60709" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1647, + "assayComponentEndpointName": "CLD_CYP1A1_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP1A1_48hr was analyzed at the endpoint, CLD_CYP1A1_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP1A1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 874, + "assayComponentName": "CLD_CYP1A1_48hr", + "assayComponentDesc": "CLD_CYP1A1_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP1A1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 77, + "geneName": "cytochrome P450, family 1, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP1A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1543, + "officialSymbol": "CYP1A1", + "officialFullName": "cytochrome P450, family 1, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "P04798" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1648, + "assayComponentEndpointName": "CLD_CYP1A2_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP1A2_48hr was analyzed at the endpoint, CLD_CYP1A2_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP1A2. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 875, + "assayComponentName": "CLD_CYP1A2_48hr", + "assayComponentDesc": "CLD_CYP1A2_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP1A2 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 78, + "geneName": "cytochrome P450, family 1, subfamily A, polypeptide 2", + "description": null, + "geneSymbol": "CYP1A2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1544, + "officialSymbol": "CYP1A2", + "officialFullName": "cytochrome P450, family 1, subfamily A, polypeptide 2", + "uniprotAccessionNumber": "P05177" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1649, + "assayComponentEndpointName": "CLD_CYP2B6_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP2B6_48hr was analyzed at the endpoint, CLD_CYP2B6_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP2B6. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 876, + "assayComponentName": "CLD_CYP2B6_48hr", + "assayComponentDesc": "CLD_CYP2B6_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP2B6 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 82, + "geneName": "cytochrome P450, family 2, subfamily B, polypeptide 6", + "description": null, + "geneSymbol": "CYP2B6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1555, + "officialSymbol": "CYP2B6", + "officialFullName": "cytochrome P450, family 2, subfamily B, polypeptide 6", + "uniprotAccessionNumber": "P20813" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1650, + "assayComponentEndpointName": "CLD_CYP2C19_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP2C19_48hr was analyzed at the endpoint, CLD_CYP2C19_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP2C19. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 877, + "assayComponentName": "CLD_CYP2C19_48hr", + "assayComponentDesc": "CLD_CYP2C19_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP2C19 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 83, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "description": null, + "geneSymbol": "CYP2C19", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1557, + "officialSymbol": "CYP2C19", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "uniprotAccessionNumber": "P33261" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1651, + "assayComponentEndpointName": "CLD_CYP2C9_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP2C9_48hr was analyzed at the endpoint, CLD_CYP2C9_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP2C9. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 878, + "assayComponentName": "CLD_CYP2C9_48hr", + "assayComponentDesc": "CLD_CYP2C9_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP2C9 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 85, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 9", + "description": null, + "geneSymbol": "CYP2C9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1559, + "officialSymbol": "CYP2C9", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 9", + "uniprotAccessionNumber": "P11712" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1652, + "assayComponentEndpointName": "CLD_CYP3A4_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_CYP3A4_48hr was analyzed at the endpoint, CLD_CYP3A4_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP3A4. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 879, + "assayComponentName": "CLD_CYP3A4_48hr", + "assayComponentDesc": "CLD_CYP3A4_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "CYP3A4 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 90, + "geneName": "cytochrome P450, family 3, subfamily A, polypeptide 4", + "description": null, + "geneSymbol": "CYP3A4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1576, + "officialSymbol": "CYP3A4", + "officialFullName": "cytochrome P450, family 3, subfamily A, polypeptide 4", + "uniprotAccessionNumber": "P08684" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1653, + "assayComponentEndpointName": "CLD_GAPDH_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_GAPDH_48hr was analyzed at the endpoint, CLD_GAPDH_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene GAPDH. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where subfamily is baseline control.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 880, + "assayComponentName": "CLD_GAPDH_48hr", + "assayComponentDesc": "CLD_GAPDH_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "GAPDH qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 138, + "geneName": "glyceraldehyde-3-phosphate dehydrogenase", + "description": null, + "geneSymbol": "GAPDH", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2597, + "officialSymbol": "GAPDH", + "officialFullName": "glyceraldehyde-3-phosphate dehydrogenase", + "uniprotAccessionNumber": "P04406" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1654, + "assayComponentEndpointName": "CLD_GSTA2_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_GSTA2_48hr was analyzed at the endpoint, CLD_GSTA2_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene GSTA2. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where subfamily is alkyl and aryl transferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "alkyl and aryl transferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 881, + "assayComponentName": "CLD_GSTA2_48hr", + "assayComponentDesc": "CLD_GSTA2_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "GSTA2 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 147, + "geneName": "glutathione S-transferase alpha 2", + "description": null, + "geneSymbol": "GSTA2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2939, + "officialSymbol": "GSTA2", + "officialFullName": "glutathione S-transferase alpha 2", + "uniprotAccessionNumber": "P09210" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1655, + "assayComponentEndpointName": "CLD_HMGCS2_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_HMGCS2_48hr was analyzed at the endpoint, CLD_HMGCS2_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene HMGCS2. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the lyase intended target family, where subfamily is HMG-CoA synthase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "lyase", + "intendedTargetFamilySub": "HMG-CoA synthase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 882, + "assayComponentName": "CLD_HMGCS2_48hr", + "assayComponentDesc": "CLD_HMGCS2_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "HMGCS2 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 154, + "geneName": "3-hydroxy-3-methylglutaryl-CoA synthase 2 (mitochondrial)", + "description": null, + "geneSymbol": "HMGCS2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3158, + "officialSymbol": "HMGCS2", + "officialFullName": "3-hydroxy-3-methylglutaryl-CoA synthase 2 (mitochondrial)", + "uniprotAccessionNumber": "P54868" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1656, + "assayComponentEndpointName": "CLD_SLCO1B1_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_SLCO1B1_48hr was analyzed at the endpoint, CLD_SLCO1B1_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene SLCO1B1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where subfamily is organic anion transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "organic anion transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 883, + "assayComponentName": "CLD_SLCO1B1_48hr", + "assayComponentDesc": "CLD_SLCO1B1_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "SLCO1B1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 367, + "geneName": "solute carrier organic anion transporter family, member 1B1", + "description": null, + "geneSymbol": "SLCO1B1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10599, + "officialSymbol": "SLCO1B1", + "officialFullName": "solute carrier organic anion transporter family, member 1B1", + "uniprotAccessionNumber": "Q9Y6L6" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1657, + "assayComponentEndpointName": "CLD_SULT2A_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_SULT2A_48hr was analyzed at the endpoint, CLD_SULT2A_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene SULT2A1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where subfamily is sulfotransferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "sulfotransferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 884, + "assayComponentName": "CLD_SULT2A_48hr", + "assayComponentDesc": "CLD_SULT2A_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "SULT2A1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 307, + "geneName": "sulfotransferase family, cytosolic, 2A, dehydroepiandrosterone (DHEA)-preferring, member 1", + "description": null, + "geneSymbol": "SULT2A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6822, + "officialSymbol": "SULT2A1", + "officialFullName": "sulfotransferase family, cytosolic, 2A, dehydroepiandrosterone (DHEA)-preferring, member 1", + "uniprotAccessionNumber": "Q06520" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1658, + "assayComponentEndpointName": "CLD_UGT1A1_48hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CLD_UGT1A1_48hr was analyzed at the endpoint, CLD_UGT1A1_48hr, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene UGT1A1. Furthermore, this assay endpoint can be referred to as a primary readout. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transferase intended target family, where subfamily is glucuronosyltransferase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "gain", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transferase", + "intendedTargetFamilySub": "glucuronosyltransferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 885, + "assayComponentName": "CLD_UGT1A1_48hr", + "assayComponentDesc": "CLD_UGT1A1_48hr is one of 16 assay component(s) measured or calculated from the CLD_48hr assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with chemiluminescence signals by Quantitative Nuclease Protection Assay (qNPA) technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": null, + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "Quantitative Nuclease Protection Assay (qNPA)", + "keyAssayReagentType": "coupled substrate", + "keyAssayReagent": "UGT1A1 qNPA probes", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 401, + "assayName": "CLD_48hr", + "assayDesc": "CLD_48hr is a cell-based, multiplexed-readout assay that uses hepatocyte, a human liver primary cell, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "primary cell", + "cellFreeComponentSource": "", + "cellShortName": "hepatocyte", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 11, + "assaySourceName": "CLD", + "assaySourceLongName": "CellzDirect", + "assaySourceDesc": "Formerly CellzDirect, this Contract Research Organization (CRO) is now part of the Invitrogen brand of Thermo Fisher providing cell-based in vitro assay screening services using primary hepatocytes.", + "gene": { + "geneId": 430, + "geneName": "UDP glucuronosyltransferase 1 family, polypeptide A1", + "description": null, + "geneSymbol": "UGT1A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 54658, + "officialSymbol": "UGT1A1", + "officialFullName": "UDP glucuronosyltransferase 1 family, polypeptide A1", + "uniprotAccessionNumber": "P22309" + }, + "assayList": null, + "citations": { + "doi": " doi: 10.1080/10937404.2010.483949", + "url": "https://pubmed.ncbi.nlm.nih.gov/20574906/", + "pmid": 20574906, + "title": "Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals", + "author": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS", + "citation": "Rotroff DM, Beam AL, Dix DJ, Farmer A, Freeman KM, Houck KA, Judson RS, LeCluyse EL, Martin MT, Reif DM, Ferguson SS. Xenobiotic-metabolizing enzyme and transporter gene expression in primary cultures of human hepatocytes modulated by ToxCast chemicals. J Toxicol Environ Health B Crit Rev. 2010 Feb;13(2-4):329-46. doi: 10.1080/10937404.2010.483949. PMID: 20574906.", + "otherId": "0", + "citationId": 246, + "otherSource": "" + } + }, + { + "aeid": 1659, + "assayComponentEndpointName": "TOX21_RAR_LUC_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_RAR_LUC_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_RAR_LUC_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene RARA. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Retinol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1013, + "assayComponentName": "TOX21_RAR_LUC_Agonist", + "assayComponentDesc": "TOX21_RAR_LUC_Agonist is one of one assay component(s) measured or calculated from the TOX21_RAR_LUC_Agonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology", + "assayComponentTargetDesc": "TOX21_RAR_LUC_Agonist was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human retinoic acid receptor alpha [GeneSymbol:RARA]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 425, + "assayName": "TOX21_RAR_LUC_Agonist", + "assayDesc": "TOX21_RAR_LUC_Agonist is a cell-based, single-readout assay that uses C3H10T1/2, a mouse sarcoma cell line, with measurements taken at 6 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 6.0, + "organismId": 10090, + "organism": "mouse", + "tissue": "embryo", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "C3H10T1/2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 279, + "geneName": "retinoic acid receptor, alpha", + "description": null, + "geneSymbol": "RARA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5914, + "officialSymbol": "RARA", + "officialFullName": "retinoic acid receptor, alpha", + "uniprotAccessionNumber": "P10276" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1660, + "assayComponentEndpointName": "TOX21_RAR_LUC_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RAR_LUC_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1014, + "assayComponentName": "TOX21_RAR_LUC_Agonist_viability", + "assayComponentDesc": "TOX21_RAR_LUC_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 425, + "assayName": "TOX21_RAR_LUC_Agonist", + "assayDesc": "TOX21_RAR_LUC_Agonist is a cell-based, single-readout assay that uses C3H10T1/2, a mouse sarcoma cell line, with measurements taken at 6 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 6.0, + "organismId": 10090, + "organism": "mouse", + "tissue": "embryo", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "C3H10T1/2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 1661, + "assayComponentEndpointName": "TOX21_RORg_LUC_CHO_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_RORg_LUC_CHO_Antagonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_RORg_LUC_CHO_Antagonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR1F3. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TO-901317", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1015, + "assayComponentName": "TOX21_RORg_LUC_CHO_Antagonist", + "assayComponentDesc": "TOX21_RORg_LUC_CHO_Antagonist is one of one assay component(s) measured or calculated from the TOX21_RORg_LUC_CHO_Antagonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology", + "assayComponentTargetDesc": "TOX21_RORg_LUC_CHO_Antagonist was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human retinoid-related orphan receptor gamma [GeneSymbol:NR1F3]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 426, + "assayName": "TOX21_RORg_LUC_CHO_Antagonist", + "assayDesc": "TOX21_RORg_LUC_CHO_Antagonist is a cell-based, single-readout assay that uses CHO-K1, a chinese hamster ovary cell line, with measurements taken at 17 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 17.0, + "organismId": 10029, + "organism": "chinese hamster", + "tissue": "ovary", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "CHO-K1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 286, + "geneName": "RAR-related orphan receptor C", + "description": null, + "geneSymbol": "RORC", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6097, + "officialSymbol": "RORC", + "officialFullName": "RAR-related orphan receptor C", + "uniprotAccessionNumber": "P51449" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1662, + "assayComponentEndpointName": "TOX21_RORg_LUC_CHO_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RORg_LUC_CHO_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1016, + "assayComponentName": "TOX21_RORg_LUC_CHO_Antagonist_viability", + "assayComponentDesc": "TOX21_RORg_LUC_CHO_Antagonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTox Green", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 426, + "assayName": "TOX21_RORg_LUC_CHO_Antagonist", + "assayDesc": "TOX21_RORg_LUC_CHO_Antagonist is a cell-based, single-readout assay that uses CHO-K1, a chinese hamster ovary cell line, with measurements taken at 17 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 17.0, + "organismId": 10029, + "organism": "chinese hamster", + "tissue": "ovary", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "CHO-K1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 1664, + "assayComponentEndpointName": "CEETOX_H295R_MTT_cell_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CEETOX_H295R_MTT_cell_viability was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter in the MTT cytotoxicity assay, gain or loss-of-signal activity can be used to monitor cellular processes to understand changes in proliferation. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is proliferation.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1017, + "assayComponentName": "CEETOX_H295R_MTT_cell_viability", + "assayComponentDesc": "CEETOX_H295R_MTT_cell_viability is one of 23 assay component(s) measured or calculated from the CEETOX_H295R assay. It is designed to make measurements of cell number, a form of viability reporter, as detected with fluorescence intensity signals by MTT cytotoxicity assay technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell number", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "MTT cytotoxicity assay", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "MTT reagent", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": null, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 1682, + "assayComponentEndpointName": "STM_H9_CystineISnorm_perc", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component STM_H9_CystineISnorm_perc was analyzed at the assay endpoint STM_H9_CystineISnorm_perc in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand relative metabolite change.", + "assayFunctionType": "relative metabolite change", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Methotrexate", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "secretome metabolite", + "intendedTargetFamily": "metabolite", + "intendedTargetFamilySub": "Cystine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1027, + "assayComponentName": "STM_H9_CystineISnorm_perc", + "assayComponentDesc": "STM_H9_CystineISnorm_perc is one of 10 components calculated in the STM_H9_secretome assay. It measures the integrated area of the endogenous cystine normalized to the spiked-in isotopically labeled standard and to the median value of the 0.1% DMSO neutral control treatment using UPLC-HRMS technology.", + "assayComponentTargetDesc": "Changes in cystine utilization relative to the neutral control.", + "parameterReadoutType": "single", + "assayDesignType": "biochemical reporter", + "assayDesignTypeSub": "metabolite detection", + "biologicalProcessTarget": "metabolism", + "detectionTechnologyType": "Mass spectrometry", + "detectionTechnologyTypeSub": "integrated area of the endogenous cystine normalized to the spiked-in isotopically labeled standard normalized the median value of the 0.1% DMSO neutral control treatment ", + "detectionTechnology": "UPLC-HRMS", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "cystine/C13Cystine/DMSO", + "technologicalTargetType": "metabolite", + "technologicalTargetTypeSub": "cystine/C13Cystine", + "aid": 428, + "assayName": "STM_H9_secretome", + "assayDesc": "STM_H9_secretome utilizes undifferentiated H9 cells to measure relative changes in two metabolites, ornithine (ORN) and cystine (CYSS) in the secretome, targeting a critical drop in the ORN/CYSS ratio as a biomarker for developmental toxicity.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-based", + "cellFreeComponentSource": "H9 embryonic stem cell line", + "cellShortName": "hESC", + "cellGrowthMode": "monolayer", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "metabolomic", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 14, + "assaySourceName": "STM", + "assaySourceLongName": "Stemina Biomarker Discovery", + "assaySourceDesc": "Stemina Biomarker Discovery is a Contract Research Organization (CRO) that provides stem cell-based developmental toxicity screening for chemical compounds. ", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa014", + "url": "https://pubmed.ncbi.nlm.nih.gov/32073639/", + "pmid": 32073639, + "title": "Profiling the ToxCast Library With a Pluripotent Human (H9) Stem Cell Line-Based Biomarker Assay for Developmental Toxicity", + "author": "Zurlinden TJ, Saili KS, Rush N, Kothiya P, Judson RS, Houck KA, Hunter ES, Baker NC, Palmer JA, Thomas RS, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Rush N, Kothiya P, Judson RS, Houck KA, Hunter ES, Baker NC, Palmer JA, Thomas RS, Knudsen TB. Profiling the ToxCast Library With a Pluripotent Human (H9) Stem Cell Line-Based Biomarker Assay for Developmental Toxicity. Toxicol Sci. 2020 Apr 1;174(2):189-209. doi: 10.1093/toxsci/kfaa014. PMID: 32073639.", + "otherId": "0", + "citationId": 248, + "otherSource": "" + } + }, + { + "aeid": 1688, + "assayComponentEndpointName": "STM_H9_OrnithineISnorm_perc", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component STM_H9_OrnithineISnorm_perc was analyzed at the assay endpoint STM_H9_OrnithineISnorm_perc in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand relative metabolite change.", + "assayFunctionType": "relative metabolite change", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Methotrexate", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "secretome metabolite", + "intendedTargetFamily": "metabolite", + "intendedTargetFamilySub": "Ornithine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1030, + "assayComponentName": "STM_H9_OrnithineISnorm_perc", + "assayComponentDesc": "STM_H9_OrnithineISnorm is one of 10 components calculated in the STM_H9_secretome assay. It measures the integrated area of the endogenous ornithine normalized to the spiked-in isotopically labeled standard and to the median value of the 0.1% DMSO neutral control treatment using UPLC-HRMS technology.", + "assayComponentTargetDesc": "Changes in ornithine release relative to the neutral control. ", + "parameterReadoutType": "single", + "assayDesignType": "biochemical reporter", + "assayDesignTypeSub": "metabolite detection", + "biologicalProcessTarget": "metabolism", + "detectionTechnologyType": "Mass spectrometry", + "detectionTechnologyTypeSub": "integrated area of the endogenous ornithine normalized to the spiked-in isotopically labeled standard normalized the median value of the 0.1% DMSO neutral control treatment ", + "detectionTechnology": "UPLC-HRMS", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Ornithine/C13Ornithine/DMSO", + "technologicalTargetType": "metabolite", + "technologicalTargetTypeSub": "ornithine/C13Ornithine", + "aid": 428, + "assayName": "STM_H9_secretome", + "assayDesc": "STM_H9_secretome utilizes undifferentiated H9 cells to measure relative changes in two metabolites, ornithine (ORN) and cystine (CYSS) in the secretome, targeting a critical drop in the ORN/CYSS ratio as a biomarker for developmental toxicity.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-based", + "cellFreeComponentSource": "H9 embryonic stem cell line", + "cellShortName": "hESC", + "cellGrowthMode": "monolayer", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "metabolomic", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 14, + "assaySourceName": "STM", + "assaySourceLongName": "Stemina Biomarker Discovery", + "assaySourceDesc": "Stemina Biomarker Discovery is a Contract Research Organization (CRO) that provides stem cell-based developmental toxicity screening for chemical compounds. ", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa014", + "url": "https://pubmed.ncbi.nlm.nih.gov/32073639/", + "pmid": 32073639, + "title": "Profiling the ToxCast Library With a Pluripotent Human (H9) Stem Cell Line-Based Biomarker Assay for Developmental Toxicity", + "author": "Zurlinden TJ, Saili KS, Rush N, Kothiya P, Judson RS, Houck KA, Hunter ES, Baker NC, Palmer JA, Thomas RS, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Rush N, Kothiya P, Judson RS, Houck KA, Hunter ES, Baker NC, Palmer JA, Thomas RS, Knudsen TB. Profiling the ToxCast Library With a Pluripotent Human (H9) Stem Cell Line-Based Biomarker Assay for Developmental Toxicity. Toxicol Sci. 2020 Apr 1;174(2):189-209. doi: 10.1093/toxsci/kfaa014. PMID: 32073639.", + "otherId": "0", + "citationId": 248, + "otherSource": "" + } + }, + { + "aeid": 1690, + "assayComponentEndpointName": "STM_H9_OrnCyssISnorm_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component STM_H9_OrnCyssISnorm_ratio was analyzed at the assay endpoint STM_H9_OrnCyssISnorm_ratio in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of binding reporter, gain or loss-of-signal activity can be used to understand relative metabolite change.", + "assayFunctionType": "relative metabolite change", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Methotrexate", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "secretome metabolite", + "intendedTargetFamily": "metabolite", + "intendedTargetFamilySub": "Ornithine/Cystine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1031, + "assayComponentName": "STM_H9_OrnCyssISnorm_ratio", + "assayComponentDesc": "STM_H9_OrnCyssISnorm_ratio is one of 10 components calculated in the STM_H9_secretome assay. It is the ratio value of OrnISnorm_perc to CyssISnorm_perc.", + "assayComponentTargetDesc": "Change in the ratio value of Orn release to Cyss utilization, indicative of the targeted biomarker of the assay. ", + "parameterReadoutType": "single", + "assayDesignType": "ratiometric", + "assayDesignTypeSub": "metabolite ratio", + "biologicalProcessTarget": "metabolism", + "detectionTechnologyType": "Mass spectrometry", + "detectionTechnologyTypeSub": "Orn:Cyss ratio calculated from DMSO-normalized values ", + "detectionTechnology": "UPLC-HRMS", + "keyAssayReagentType": "ratio", + "keyAssayReagent": "ornithine/cystine", + "technologicalTargetType": "metabolite", + "technologicalTargetTypeSub": "ornithine/cystine", + "aid": 428, + "assayName": "STM_H9_secretome", + "assayDesc": "STM_H9_secretome utilizes undifferentiated H9 cells to measure relative changes in two metabolites, ornithine (ORN) and cystine (CYSS) in the secretome, targeting a critical drop in the ORN/CYSS ratio as a biomarker for developmental toxicity.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-based", + "cellFreeComponentSource": "H9 embryonic stem cell line", + "cellShortName": "hESC", + "cellGrowthMode": "monolayer", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "metabolomic", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 14, + "assaySourceName": "STM", + "assaySourceLongName": "Stemina Biomarker Discovery", + "assaySourceDesc": "Stemina Biomarker Discovery is a Contract Research Organization (CRO) that provides stem cell-based developmental toxicity screening for chemical compounds. ", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa014", + "url": "https://pubmed.ncbi.nlm.nih.gov/32073639/", + "pmid": 32073639, + "title": "Profiling the ToxCast Library With a Pluripotent Human (H9) Stem Cell Line-Based Biomarker Assay for Developmental Toxicity", + "author": "Zurlinden TJ, Saili KS, Rush N, Kothiya P, Judson RS, Houck KA, Hunter ES, Baker NC, Palmer JA, Thomas RS, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Rush N, Kothiya P, Judson RS, Houck KA, Hunter ES, Baker NC, Palmer JA, Thomas RS, Knudsen TB. Profiling the ToxCast Library With a Pluripotent Human (H9) Stem Cell Line-Based Biomarker Assay for Developmental Toxicity. Toxicol Sci. 2020 Apr 1;174(2):189-209. doi: 10.1093/toxsci/kfaa014. PMID: 32073639.", + "otherId": "0", + "citationId": 248, + "otherSource": "" + } + }, + { + "aeid": 1744, + "assayComponentEndpointName": "NVS_ENZ_hPPP3CA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPPP3CA was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPPP3CA, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PPP3CA.\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is serine/threonine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "serine/threonine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1034, + "assayComponentName": "NVS_ENZ_hPPP3CA", + "assayComponentDesc": "NVS_ENZ_hPPP3CA is one of one assay component(s) measured or calculated from the NVS_ENZ_hPPP3CA assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein phosphatase 3, catalytic subunit, alpha isozyme [GeneSymbol:PPP3CA | GeneID:5530 |.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 429, + "assayName": "NVS_ENZ_hPPP3CA", + "assayDesc": "NVS_ENZ_hPPP3CA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 5655, + "geneName": "protein phosphatase 3 catalytic subunit alpha", + "description": null, + "geneSymbol": "PPP3CA", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 5530, + "officialSymbol": "PPP3CA", + "officialFullName": "protein phosphatase 3 catalytic subunit alpha", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 1746, + "assayComponentEndpointName": "ATG_GPCR_ADORA2A_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_ADORA2A_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ADORA2A. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1035, + "assayComponentName": "ATG_GPCR_ADORA2A_TRANS", + "assayComponentDesc": "ATG_GPCR_ADORA2A_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene ADORA2A, which is responsive to the adenosine A2a receptor [GeneSymbol:ADORA2A| GeneID:135 | Uniprot_SwissProt_Accession:P29274].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ADORA2A RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 11, + "geneName": "adenosine A2a receptor", + "description": null, + "geneSymbol": "ADORA2A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 135, + "officialSymbol": "ADORA2A", + "officialFullName": "adenosine A2a receptor", + "uniprotAccessionNumber": "P29274" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1748, + "assayComponentEndpointName": "ATG_GPCR_ADORA2B_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_ADORA2B_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ADORA2B. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1036, + "assayComponentName": "ATG_GPCR_ADORA2B_TRANS", + "assayComponentDesc": "ATG_GPCR_ADORA2B_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene ADORA2B, which is responsive to the adenosine A2b receptor [GeneSymbol:ADORA2B| GeneID:136 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ADORA2B RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 482, + "geneName": "adenosine A2b receptor", + "description": null, + "geneSymbol": "ADORA2B", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 136, + "officialSymbol": "ADORA2B", + "officialFullName": "adenosine A2b receptor", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1750, + "assayComponentEndpointName": "ATG_GPCR_ADRA1A_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_ADRA1A_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ADRA1A. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1037, + "assayComponentName": "ATG_GPCR_ADRA1A_TRANS", + "assayComponentDesc": "ATG_GPCR_ADRA1A_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene ADRA1A, which is responsive to the adrenoceptor alpha 1A. [GeneSymbol:ADRA1A| GeneID:148 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ADRA1A RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 483, + "geneName": "adrenoceptor alpha 1A", + "description": null, + "geneSymbol": "ADRA1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 148, + "officialSymbol": "ADRA1A", + "officialFullName": "adrenoceptor alpha 1A", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1752, + "assayComponentEndpointName": "ATG_GPCR_ADRA2B_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_ADRA2B_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ADRA2B. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1038, + "assayComponentName": "ATG_GPCR_ADRA2B_TRANS", + "assayComponentDesc": "ATG_GPCR_ADRA2B_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene ADRA2B, which is responsive to the adrenoceptor alpha 2B. [GeneSymbol:ADRA2B| GeneID:151 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ADRA2B RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 484, + "geneName": "adrenoceptor alpha 2B", + "description": null, + "geneSymbol": "ADRA2B", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 151, + "officialSymbol": "ADRA2B ", + "officialFullName": "adrenoceptor alpha 2B", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1754, + "assayComponentEndpointName": "ATG_GPCR_ADRB2_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_ADRB2_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ADRB2. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1039, + "assayComponentName": "ATG_GPCR_ADRB2_TRANS", + "assayComponentDesc": "ATG_GPCR_ADRB2_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene ADRB2, which is responsive to the adrenoceptor beta 2, surface. [GeneSymbol:ADRB2| GeneID:154 | Uniprot_SwissProt_Accession: P07550].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ADRB2 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 16, + "geneName": "adrenoceptor beta 2, surface", + "description": null, + "geneSymbol": "ADRB2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 154, + "officialSymbol": "ADRB2", + "officialFullName": "adrenoceptor beta 2, surface", + "uniprotAccessionNumber": "P07550" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1756, + "assayComponentEndpointName": "ATG_GPCR_ADRB3_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_ADRB3_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ADRB3. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1040, + "assayComponentName": "ATG_GPCR_ADRB3_TRANS", + "assayComponentDesc": "ATG_GPCR_ADRB3_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene ADRB3, which is responsive to the adrenoceptor beta 3. [GeneSymbol:ADRB3| GeneID:155 | Uniprot_SwissProt_Accession: P13945].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ADRB3 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 17, + "geneName": "adrenoceptor beta 3", + "description": null, + "geneSymbol": "ADRB3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 155, + "officialSymbol": "ADRB3", + "officialFullName": "adrenoceptor beta 3", + "uniprotAccessionNumber": "P13945" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1758, + "assayComponentEndpointName": "ATG_GPCR_CHRM3_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_CHRM3_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene CHRM3. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1041, + "assayComponentName": "ATG_GPCR_CHRM3_TRANS", + "assayComponentDesc": "ATG_GPCR_CHRM3_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene CHRM3, which is responsive to the cholinergic receptor, muscarinic 3. [GeneSymbol:CHRM3| GeneID:1131 | Uniprot_SwissProt_Accession: P20309].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "CHRM3 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 63, + "geneName": "cholinergic receptor, muscarinic 3", + "description": null, + "geneSymbol": "CHRM3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1131, + "officialSymbol": "CHRM3", + "officialFullName": "cholinergic receptor, muscarinic 3", + "uniprotAccessionNumber": "P20309" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1760, + "assayComponentEndpointName": "ATG_GPCR_DRD1_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_DRD1_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene DRD1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1042, + "assayComponentName": "ATG_GPCR_DRD1_TRANS", + "assayComponentDesc": "ATG_GPCR_DRD1_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene DRD1, which is responsive to the dopamine receptor D1. [GeneSymbol:DRD1| GeneID:1812 | Uniprot_SwissProt_Accession: P21728].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "DRD1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 99, + "geneName": "dopamine receptor D1", + "description": null, + "geneSymbol": "DRD1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1812, + "officialSymbol": "DRD1", + "officialFullName": "dopamine receptor D1", + "uniprotAccessionNumber": "P21728" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1762, + "assayComponentEndpointName": "ATG_GPCR_DRD5_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_DRD5_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene DRD5. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1043, + "assayComponentName": "ATG_GPCR_DRD5_TRANS", + "assayComponentDesc": "ATG_GPCR_DRD5_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene DRD5, which is responsive to the dopamine receptor D5. [GeneSymbol:DRD5| GeneID:1816 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "DRD5 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 485, + "geneName": "dopamine receptor D5", + "description": null, + "geneSymbol": "DRD5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1816, + "officialSymbol": "DRD5", + "officialFullName": "dopamine receptor D5", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1764, + "assayComponentEndpointName": "ATG_GPCR_EDNRA_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_EDNRA_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene EDNRA. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1044, + "assayComponentName": "ATG_GPCR_EDNRA_TRANS", + "assayComponentDesc": "ATG_GPCR_EDNRA_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene EDNRA, which is responsive to the endothelin receptor type A. [GeneSymbol:EDNRA| GeneID: 1909 | Uniprot_SwissProt_Accession: P25101].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "EDNRA RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 105, + "geneName": "endothelin receptor type A", + "description": null, + "geneSymbol": "EDNRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1909, + "officialSymbol": "EDNRA", + "officialFullName": "endothelin receptor type A", + "uniprotAccessionNumber": "P25101" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1766, + "assayComponentEndpointName": "ATG_GPCR_GCGR_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_GCGR_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene GCGR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1045, + "assayComponentName": "ATG_GPCR_GCGR_TRANS", + "assayComponentDesc": "ATG_GPCR_GCGR_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene GCGR, which is responsive to the glucagon receptor. [GeneSymbol: GCGR| GeneID: 2642 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GCGR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 486, + "geneName": "glucagon receptor", + "description": null, + "geneSymbol": "GCGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2642, + "officialSymbol": "GCGR", + "officialFullName": "glucagon receptor", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1768, + "assayComponentEndpointName": "ATG_GPCR_GPBAR1_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_GPBAR1_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene GPBAR1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1046, + "assayComponentName": "ATG_GPCR_GPBAR1_TRANS", + "assayComponentDesc": "ATG_GPCR_GPBAR1_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene GPBAR1, which is responsive to the G protein-coupled bile acid receptor 1. [GeneSymbol: GPBAR1| GeneID: 1501306 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GPBAR1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 487, + "geneName": "G protein-coupled bile acid receptor 1", + "description": null, + "geneSymbol": "GPBAR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 151306, + "officialSymbol": "GPBAR1", + "officialFullName": "G protein-coupled bile acid receptor 1", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1770, + "assayComponentEndpointName": "ATG_GPCR_GPR40_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_GPR40_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene GPR40. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1047, + "assayComponentName": "ATG_GPCR_GPR40_TRANS", + "assayComponentDesc": "ATG_GPCR_GPR40_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene FFAR1, which is responsive to the free fatty acid receptor 1. [GeneSymbol: FFAR1| GeneID: 2864 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GPR40 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 488, + "geneName": "free fatty acid receptor 1", + "description": null, + "geneSymbol": "FFAR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2864, + "officialSymbol": "FFAR1", + "officialFullName": "free fatty acid receptor 1", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1772, + "assayComponentEndpointName": "ATG_GPCR_GQ_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_GQ_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene GNAQ. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1048, + "assayComponentName": "ATG_GPCR_GQ_TRANS", + "assayComponentDesc": "ATG_GPCR_GQ_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene GNAQ, which is responsive to the G protein subunit alpha q. [GeneSymbol: GNAQ| GeneID: 2776 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GQ RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 3599, + "geneName": "G protein subunit alpha q", + "description": null, + "geneSymbol": "GNAQ", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 2776, + "officialSymbol": "GNAQ", + "officialFullName": "G protein subunit alpha q", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1774, + "assayComponentEndpointName": "ATG_GPCR_GS1_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_GS1_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene GNAS. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1049, + "assayComponentName": "ATG_GPCR_GS1_TRANS", + "assayComponentDesc": "ATG_GPCR_GS1_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene GNAS, which is responsive to the GNAS complex locus. [GeneSymbol: GNAS| GeneID: 2778 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GS1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 3601, + "geneName": "GNAS complex locus", + "description": null, + "geneSymbol": "GNAS", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 2778, + "officialSymbol": "GNAS", + "officialFullName": "GNAS complex locus", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1776, + "assayComponentEndpointName": "ATG_GPCR_GS_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_GS_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene GNAS. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1050, + "assayComponentName": "ATG_GPCR_GS_TRANS", + "assayComponentDesc": "ATG_GPCR_GS_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene GNAS, which is responsive to the GNAS complex locus. [GeneSymbol: GNAS| GeneID: 2778 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GS RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 3601, + "geneName": "GNAS complex locus", + "description": null, + "geneSymbol": "GNAS", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 2778, + "officialSymbol": "GNAS", + "officialFullName": "GNAS complex locus", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1778, + "assayComponentEndpointName": "ATG_GPCR_HRH1_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_HRH1_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene HRH1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1051, + "assayComponentName": "ATG_GPCR_HRH1_TRANS", + "assayComponentDesc": "ATG_GPCR_HRH1_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene HRH1, which is responsive to the histamine receptor H1. [GeneSymbol: HRH1| GeneID: 3269 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "HRH1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 160, + "geneName": "histamine receptor H1", + "description": null, + "geneSymbol": "HRH1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3269, + "officialSymbol": "HRH1", + "officialFullName": "histamine receptor H1", + "uniprotAccessionNumber": "P35367" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1780, + "assayComponentEndpointName": "ATG_GPCR_HTR6_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_HTR6_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene HTR6. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1052, + "assayComponentName": "ATG_GPCR_HTR6_TRANS", + "assayComponentDesc": "ATG_GPCR_HTR6_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene HTR6, which is responsive to the 5-hydroxytryptamine (serotonin) receptor 6, G. [GeneSymbol: HTR6| GeneID: 3362 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "HTR6 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 168, + "geneName": "5-hydroxytryptamine (serotonin) receptor 6, G protein-coupled", + "description": null, + "geneSymbol": "HTR6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3362, + "officialSymbol": "HTR6", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 6, G protein-coupled", + "uniprotAccessionNumber": "P50406" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1782, + "assayComponentEndpointName": "ATG_GPCR_HTR7_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_HTR7_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene HTR7. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1053, + "assayComponentName": "ATG_GPCR_HTR7_TRANS", + "assayComponentDesc": "ATG_GPCR_HTR7_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene HTR7, which is responsive to the 5-hydroxytryptamine (serotonin) receptor 7. [GeneSymbol: HTR7| GeneID: 3363 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "HTR7 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 169, + "geneName": "5-hydroxytryptamine (serotonin) receptor 7, adenylate cyclase-coupled", + "description": null, + "geneSymbol": "HTR7", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3363, + "officialSymbol": "HTR7", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 7, adenylate cyclase-coupled", + "uniprotAccessionNumber": "P34969" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1784, + "assayComponentEndpointName": "ATG_GPCR_LPAR4_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_LPAR4_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene LPAR4. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1054, + "assayComponentName": "ATG_GPCR_LPAR4_TRANS", + "assayComponentDesc": "ATG_GPCR_LPAR4_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene LPAR4, which is responsive to the lysophosphatidic acid receptor 4. [GeneSymbol: LPAR4| GeneID: 2846 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "LPAR4 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 489, + "geneName": "lysophosphatidic acid receptor 4", + "description": null, + "geneSymbol": "LPAR4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2846, + "officialSymbol": "LPAR4", + "officialFullName": "lysophosphatidic acid receptor 4", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 2452, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_Apoptosis_MCF7", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_Apoptosis_MCF7 was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain-of-signal activity can be used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent to understand changes in apoptosis. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is apoptosis.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM N6", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "apoptosis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2446, + "assayComponentName": "CCTE_Harrill_HTTr_Apoptosis_MCF7", + "assayComponentDesc": "One of seven assay components measured from the CCTE_Harrill_HTTr_Apoptosis assay. This was part of a full screening experiment. This is a cell-based assay that evaluates apoptosis in MCF-7 cells cultured in DMEM + 10% fetal bovine serum. High content imaging is used to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent. Measurements are taken at 6 hours after chemical dosing in 384-well format.", + "assayComponentTargetDesc": "Caspase 3/7 kit", + "parameterReadoutType": "multiplexed", + "assayDesignType": "apoptosis reporter", + "assayDesignTypeSub": "Caspase 3/7 activity", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellEvent Caspase 3/7 Green detection reagent", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "caspase", + "aid": 666, + "assayName": "CCTE_Harrill_HTTr_Apoptosis", + "assayDesc": "This is a cell-based assay that evaluates apoptosis using high content imaging to evaluate activation of caspase-3/7 using the CellEvent Caspase 3/7 Green detection reagent in 384-well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2244, + "assayComponentEndpointName": "TOX21_TRB_COA_Agonist_Followup_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRB_COA_Antagonist_Followup_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRB_COA_Antagonist_Followup_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRB. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2305, + "assayComponentName": "TOX21_TRB_COA_Agonist_Followup_ratio", + "assayComponentDesc": "TOX21_TRB_COA_Agonist_Followup_ratio is assay component calculated in the TOX21_TRB_COA_Agonist_Followup assay. The TR-FRET ratio of acceptor emission (ch2) to donor emission (ch1) is indicative of the resonance energy transfer to the fluorescein tag on the coactivator peptide following recruitment to the receptor.", + "assayComponentTargetDesc": "Terbium-labeled anti-GST antibody indirectly labels TR by binding to the GST tag. Binding of the agonist to the TR causes a conformational change that results in an increase in the affinity of the TR for a coactivator peptide. The close proximity of the fluorescein-labeled SRC-2 coactivator peptide to the terbium-labeled antibody causes an increase in the TR-FRET signal.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "coactivator recruitment", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescein-labeled SRC-2 coactivator peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 650, + "assayName": "TOX21_TRB_COA_Agonist_Followup", + "assayDesc": "TOX21_TRb_COA_Agonist_Followup is a secondary assay for specificity for the TOX21_TR_GH3_LUC_Agonist assay. The LanthaScreen TR-FRET TR coactivator assay kits were used to determine TR activity in a cell-free functional assay. A time-resolved fluorescence resonance energy transfer (TR-FRET) signal was indicative of coactivator (SRC-2) recruitment.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 322, + "geneName": "thyroid hormone receptor, beta", + "description": null, + "geneSymbol": "THRB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7068, + "officialSymbol": "THRB", + "officialFullName": "thyroid hormone receptor, beta", + "uniprotAccessionNumber": "P10828" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2245, + "assayComponentEndpointName": "TOX21_TRB_COA_Antagonist_Followup_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRB_COA_Antagonist_Followup_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRB_COA_Antagonist_Followup_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRB. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2306, + "assayComponentName": "TOX21_TRB_COA_Antagonist_Followup_ch1", + "assayComponentDesc": "TOX21_TRB_COA_Antagonist_Followup_ch1 is an assay readout measuring emission signals generated by coactivator recruitment. The ch1 signal is derived from donor emission and is used to calculate TR-FRET ratio of acceptor emission (ch2) to donor emission (ch1).", + "assayComponentTargetDesc": "Terbium-labeled anti-GST antibody indirectly labels TR by binding to the GST tag. Binding of the antagonist to the TR causes a conformational change that results in an decrease in the affinity of the TR for a coactivator peptide. The close proximity of the fluorescein-labeled SRC-2 coactivator peptide to the terbium-labeled antibody causes an increase in the TR-FRET signal.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescein-labeled SRC-2 coactivator peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 651, + "assayName": "TOX21_TRB_COA_Antagonist_Followup", + "assayDesc": "TOX21_TRb_COA_Antagonist_Followup is a secondary assay for specificity for the TOX21_TR_GH3_LUC_Agonist assay. The LanthaScreen TR-FRET TR coactivator assay kits were used to determine TR activity in a cell-free functional assay. A time-resolved fluorescence resonance energy transfer (TR-FRET) signal was indicative of coactivator (SRC-2) recruitment.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2246, + "assayComponentEndpointName": "TOX21_TRB_COA_Antagonist_Followup_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRB_COA_Antagonist_Followup_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRB_COA_Antagonist_Followup_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRB. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2307, + "assayComponentName": "TOX21_TRB_COA_Antagonist_Followup_ch2", + "assayComponentDesc": "TOX21_TRB_COA_Antagonist_Followup_ch2 is an assay readout measuring emission signals generated by coactivator (SRC-2) recruitment. The ch2 signal is derived from acceptor emission and is used to calculate TR-FRET ratio of acceptor emission (ch2) to donor emission (ch1).", + "assayComponentTargetDesc": "Terbium-labeled anti-GST antibody indirectly labels TR by binding to the GST tag. Binding of the antagonist to the TR causes a conformational change that results in an decrease in the affinity of the TR for a coactivator peptide. The close proximity of the fluorescein-labeled SRC-2 coactivator peptide to the terbium-labeled antibody causes an increase in the TR-FRET signal.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescein-labeled SRC-2 coactivator peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 651, + "assayName": "TOX21_TRB_COA_Antagonist_Followup", + "assayDesc": "TOX21_TRb_COA_Antagonist_Followup is a secondary assay for specificity for the TOX21_TR_GH3_LUC_Agonist assay. The LanthaScreen TR-FRET TR coactivator assay kits were used to determine TR activity in a cell-free functional assay. A time-resolved fluorescence resonance energy transfer (TR-FRET) signal was indicative of coactivator (SRC-2) recruitment.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2247, + "assayComponentEndpointName": "TOX21_TRB_COA_Antagonist_Followup_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TRB_COA_Antagonist_Followup_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TRB_COA_Antagonist_Followup_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRB. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2308, + "assayComponentName": "TOX21_TRB_COA_Antagonist_Followup_ratio", + "assayComponentDesc": "TOX21_TRB_COA_Antagonist_Followup_ratio is assay component calculated in the TOX21_TRB_COA_Antagonist_Followup assay. The TR-FRET ratio of acceptor emission (ch2) to donor emission (ch1) is indicative of the resonance energy transfer to the fluorescein tag on the coactivator peptide following recruitment to the receptor.", + "assayComponentTargetDesc": "Terbium-labeled anti-GST antibody indirectly labels TR by binding to the GST tag. Binding of the antagonist to the TR causes a conformational change that results in an decrease in the affinity of the TR for a coactivator peptide. The close proximity of the fluorescein-labeled SRC-2 coactivator peptide to the terbium-labeled antibody causes an increase in the TR-FRET signal.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "coactivator recruitment", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescein-labeled SRC-2 coactivator peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 651, + "assayName": "TOX21_TRB_COA_Antagonist_Followup", + "assayDesc": "TOX21_TRb_COA_Antagonist_Followup is a secondary assay for specificity for the TOX21_TR_GH3_LUC_Agonist assay. The LanthaScreen TR-FRET TR coactivator assay kits were used to determine TR activity in a cell-free functional assay. A time-resolved fluorescence resonance energy transfer (TR-FRET) signal was indicative of coactivator (SRC-2) recruitment.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-free", + "assayFormatTypeSub": "cell-free format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 322, + "geneName": "thyroid hormone receptor, beta", + "description": null, + "geneSymbol": "THRB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7068, + "officialSymbol": "THRB", + "officialFullName": "thyroid hormone receptor, beta", + "uniprotAccessionNumber": "P10828" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1289/EHP5314", + "url": "https://pubmed.ncbi.nlm.nih.gov/31566444/", + "pmid": 31566444, + "title": "Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library", + "author": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA", + "citation": "Paul-Friedman K, Martin M, Crofton KM, Hsu CW, Sakamuru S, Zhao J, Xia M, Huang R, Stavreva DA, Soni V, Varticovski L, Raziuddin R, Hager GL, Houck KA. Limited Chemical Structural Diversity Found to Modulate Thyroid Hormone Receptor in the Tox21 Chemical Library. Environ Health Perspect. 2019 Sep;127(9):97009. doi: 10.1289/EHP5314. Epub 2019 Sep 30. PMID: 31566444; PMCID: PMC6792352.", + "otherId": "0", + "citationId": 249, + "otherSource": "" + } + }, + { + "aeid": 2453, + "assayComponentEndpointName": "CCTE_Harrill_HTTr_CellCount_MCF7", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay component endpoint CCTE_Harrill_HTTr_CellCount_MCF7 was analyzed with bidirectional fitting relation to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand changes in cell count. To generalize the intended target to other relatable targets, this assay endpoint is annotated to cell cycle, where the subfamily is cell count.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM N6", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cell count", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2444, + "assayComponentName": "CCTE_Harrill_HTTr_CellCount_MCF7", + "assayComponentDesc": "This is a cell-based assay that evaluates cell viability and cell growth in MCF-7 cells. This was part of a full screening experiment. High content imaging is used to count the number of Hoechst-labeled nuclei that are present in an assay well in 384-well format.", + "assayComponentTargetDesc": "Count of Hoechst-labeled nuclei indicates live cell number", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell number", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst-33342 dye", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "nucleus", + "aid": 683, + "assayName": "CCTE_Harrill_HTTr_CellCount", + "assayDesc": "This is a cell-based assay that evaluates cell viability and cell growth using high content imaging to count the number of Hoechst-labeled nuclei that are present in an assay well in 384-well format.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": null, + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfab009", + "url": "https://pubmed.ncbi.nlm.nih.gov/33538836/", + "pmid": 33538836, + "title": "High-Throughput Transcriptomics Platform for Screening Environmental Chemicals", + "author": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS", + "citation": "Harrill JA, Everett LJ, Haggard DE, Sheffield T, Bundy JL, Willis CM, Thomas RS, Shah I, Judson RS. High-Throughput Transcriptomics Platform for Screening Environmental Chemicals. Toxicol Sci. 2021 Apr 27;181(1):68-89. doi: 10.1093/toxsci/kfab009. PMID: 33538836.", + "otherId": "0", + "citationId": 265, + "otherSource": "" + } + }, + { + "aeid": 2454, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_spike_number", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_spike_number was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_spike_number, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetrodotoxin", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2447, + "assayComponentName": "CCTE_Shafer_MEA_acute_spike_number", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_spike_number is a component of the CCTE_Shafer_MEA_acute assay. It measures the total number of spikes (action potential firings) in a 40-minute recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The recordings before and after chemical treatment are used to calculate a percent change in the spike number in each well. ", + "assayComponentTargetDesc": "The number of spikes is a measure of general activity in the network. Changes in electrical activity are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2456, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_firing_rate_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_firing_rate_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_firing_rate_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetrodotoxin", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2448, + "assayComponentName": "CCTE_Shafer_MEA_acute_firing_rate_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_firing_rate_mean is a component of the CCTE_Shafer_MEA_acute assay. It measures the frequency number of spikes (action potential firings) as the total number of spikes divided by the length of the recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The firing rate is divided by the number of electrodes to report a well-mean value. The recordings before and after chemical treatment are used to calculate a percent change in the mean firing rate in each well.", + "assayComponentTargetDesc": "The mean firing rate is a measure of general activity in the network. Changes in electrical activity are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2458, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_burst_number", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_burst_number was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_burst_number, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2449, + "assayComponentName": "CCTE_Shafer_MEA_acute_burst_number", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_burst_number is a component of the CCTE_Shafer_MEA_acute assay. It measures the total number of single-electrode bursts (temporally-clustered groups of action potential firing) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The recordings before and after chemical treatment are used to calculate a percent change in the burst number in each well.", + "assayComponentTargetDesc": "The number of bursts is a measure of general activity in the network. Changes in electrical activity are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2460, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_burst_duration_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_burst_duration_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_burst_duration_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: bursting activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2450, + "assayComponentName": "CCTE_Shafer_MEA_acute_burst_duration_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_burst_duration_mean is a component of the CCTE_Shafer_MEA_acute assay. It measures the average time from the first spike (action potential firing) to the last spike in a single-electrode burst (temporally-clustered group of spikes) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The recordings before and after chemical treatment are used to calculate a percent change in the mean burst duration in each well.", + "assayComponentTargetDesc": "The mean burst duration is a measure of bursting activity in a neural network. Changes in electrical activity are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 90, + "assayComponentEndpointName": "ATG_M_61_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_M_61_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_M_61_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \n\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 59, + "assayComponentName": "ATG_M_61_CIS", + "assayComponentDesc": "ATG_M_61_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene M_61, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M61 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 2462, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_per_burst_spike_number_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_per_burst_spike_number_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_per_burst_spike_number_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: bursting activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2451, + "assayComponentName": "CCTE_Shafer_MEA_acute_per_burst_spike_number_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_per_burst_spike_number_mean is a component of the CCTE_Shafer_MEA_acute assay. It measures the average number of spikes (action potential firings) in a single-electrode burst (temporally-clustered group of spikes) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The recordings before and after chemical treatment are used to calculate a percent change in the mean number of spikes per burst in each well.", + "assayComponentTargetDesc": "The mean number of spikes in a burst is a measure of bursting activity in a neural network. Changes in electrical activity are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2464, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_interburst_interval_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_interburst_interval_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_interburst_interval_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: bursting activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2452, + "assayComponentName": "CCTE_Shafer_MEA_acute_interburst_interval_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_interburst_interval_mean is a component of the CCTE_Shafer_MEA_acute assay. It measures the average time between the start of consecutive single-electrode bursts (temporally-clustered groups of action potential firing) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The recordings before and after chemical treatment are used to calculate a percent change in the mean inter-burst interval in each well.", + "assayComponentTargetDesc": "The mean inter-burst interval is a measure of bursting activity in a neural network. Changes in electrical activity are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2466, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_burst_percentage_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_burst_percentage_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_burst_percentage_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: bursting activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2453, + "assayComponentName": "CCTE_Shafer_MEA_acute_burst_percentage_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_burst_percentage_mean is a component of the CCTE_Shafer_MEA_acute assay. It measures the percentage of spikes (action potential firing) in a single-electrode burst (temporally-clustered groups of spikes) as the number of spikes in bursts divided by the total number of spikes during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The average of the burst percentages across electrodes is calculated to report a well-level value. The recordings before and after chemical treatment are used to calculate a percent change in the mean burst percentage in each well.", + "assayComponentTargetDesc": "The mean percent of spikes in bursts is a measure of bursting activity in a neural network. Changes in electrical activity are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2468, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_burst_percentage_std", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_burst_percentage_std was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_burst_percentage_std, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: bursting activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2454, + "assayComponentName": "CCTE_Shafer_MEA_acute_burst_percentage_std", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_burst_percentage_std is a component of the CCTE_Shafer_MEA_acute assay. It measures the percentage of spikes (action potential firing) in a single-electrode burst (temporally-clustered groups of spikes) as the number of spikes in bursts divided by the total number of spikes during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The standard deviation of the burst percentages across electrodes is calculated to report a well-level value. The recordings before and after chemical treatment are used to calculate a percent change in the standard deviation of the burst percentage in each well.", + "assayComponentTargetDesc": "The standard deviation of the percent of spikes in bursts is a measure of bursting activity in a neural network. Changes in electrical activity are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2470, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_per_network_burst_spike_number_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_per_network_burst_spike_number_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_per_network_burst_spike_number_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2455, + "assayComponentName": "CCTE_Shafer_MEA_acute_per_network_burst_spike_number_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_per_network_burst_spike_number_mean is a component of the CCTE_Shafer_MEA_acute assay. It measures the average number of spikes (action potential firings) in a network burst (temporally-clustered group of spikes across multiple electrodes) as the total number of spikes in a network burst divided by the number of network bursts during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The recordings before and after chemical treatment are used to calculate a percent change in the mean number of spikes in a network burst in each well.", + "assayComponentTargetDesc": "Networks bursts occur as the result of network connectivity. Changes in the mean number of spikes in a network burst are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2472, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_per_network_burst_spike_number_std", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_burst_spike_number_std was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_burst_spike_number_std, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2456, + "assayComponentName": "CCTE_Shafer_MEA_acute_per_network_burst_spike_number_std", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_per_network_burst_spike_number_std is a component of the CCTE_Shafer_MEA_acute assay. It measures the standard deviation of the number of spikes (action potential firings) in a network burst (temporally-clustered group of spikes across multiple electrodes) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The recordings before and after chemical treatment are used to calculate a percent change in the standard deviation of the number of spikes in network bursts in each well.", + "assayComponentTargetDesc": "Networks bursts occur as the result of network connectivity. Changes in the standard deviation of the number of spikes in a network burst are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2474, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_per_network_burst_electrodes_number_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_per_network_burst_electrodes_number_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_per_network_burst_electrodes_number_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2457, + "assayComponentName": "CCTE_Shafer_MEA_acute_per_network_burst_electrodes_number_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_per_network_burst_electrodes_number_mean is a component of the CCTE_Shafer_MEA_acute assay. It measures the average number of electrodes with activity during a network burst (a temporally-clustered group of action potential firing across multiple electrodes) in a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The recordings before and after chemical treatment are used to calculate a percent change in the mean number of electrodes participating in network bursts in each well.", + "assayComponentTargetDesc": "Networks bursts occur as the result of network connectivity. Changes in the average number of electrodes participating in a network burst are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2476, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_network_burst_percentage", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_network_burst_percentage was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_network_burst_percentage, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2458, + "assayComponentName": "CCTE_Shafer_MEA_acute_network_burst_percentage", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_network_burst_percentage is a component of the CCTE_Shafer_MEA_acute assay. It measures the percent of spikes (action potential firings) in network bursts (temporally-clustered groups of spikes across multiple electrodes) as the number of spikes occuring in network bursts divided by the total number of spikes during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The recordings before and after chemical treatment are used to calculate a percent change in the network burst percentage in each well.", + "assayComponentTargetDesc": "Networks bursts occur as the result of network connectivity. Changes in the percent of spikes in a network burst are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2478, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_cross_correlation_area", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_cross_correlation_area was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_cross_correlation_area, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2459, + "assayComponentName": "CCTE_Shafer_MEA_acute_cross_correlation_area", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_cross_correlation_area is a component of the CCTE_Shafer_MEA_acute assay. It measures the area under the well-wide pooled inter-electrode cross-correlation of action potential firing (not normalized to auto-correlations) within a window centered around 0 for the phase lag during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The recordings before and after chemical treatment are used to calculate a percent change in the cross correlation area in each well.", + "assayComponentTargetDesc": "The cross correlation area is a measure of the synchrony of a neural network. Changes in the synchrony are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2480, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_cross_correlation_HWHM", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_cross_correlation_HWHM was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_cross_correlation_HWHM, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2460, + "assayComponentName": "CCTE_Shafer_MEA_acute_cross_correlation_HWHM", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_cross_correlation_HWHM is a component of the CCTE_Shafer_MEA_acute assay. It measures the distance along the x-axis (phase lag) from the left half maximum height to the center of the cross-correlogram of action potential firing during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. Smaller values indicate a narrower correlogram (greater synchrony). The recordings before and after chemical treatment are used to calculate a percent change in the half width at half maximum of the cross-correlogram in each well.", + "assayComponentTargetDesc": "The half width at half maximum of the cross-correlogram is a measure of the synchrony of a neural network. Changes in the synchrony are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2482, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_synchrony_index", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_synchrony_index was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_synchrony_index, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neuroactivity", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2461, + "assayComponentName": "CCTE_Shafer_MEA_acute_synchrony_index", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_synchrony_index is a component of the CCTE_Shafer_MEA_acute assay. It measures the synchrony of the neural network as a unitless measure between 0 (low synchrony) to 1 (high synchrony) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The recordings before and after chemical treatment are used to calculate a percent change in the synchrony index in each well.", + "assayComponentTargetDesc": "The synchrony index is a measure of the synchrony of a neural network. Changes in the synchrony are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2484, + "assayComponentEndpointName": "CCTE_Deisenroth_AIME_96WELL_LUC_Active", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "CCTE_Deisenroth_AIME_96WELL_LUC_Active is a component of the CCTE_Deisenroth_AIME_96WELL assay that measures the effect of retroftting the VM7Luc ERTA assay with the Alginate Immobolization of Metabolic Enzymes (AIME) metabolism method. AIME is optimized to impart phase I hepatic metabolism using phenobarbital/beta-naphthoflavone induced hepatic S9 from male Sprague Dawley rats. Parent chemicals are incubated for 2 hours in the AIME assay prior to transfer to the VM7Luc ERTA assay plate. The AIME metabolism assay is run simultaneously in negative (inactive) and positive (active) modes to evaluate the activity of parent and metabolites, respectively. This endpoint evaluates reporter induction in metabolism positive mode. Using a type of inducible reporter in VM7Luc cells, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to xenobiotic metabolism and the gene ESR1. This assay endpoint, CCTE_Deisenroth_AIME_96WELL_LUC_Active, was analyzed in the positive analysis fitting direction relative to 17beta-estradiol as the positive control in the ERTA assay. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17beta-estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2462, + "assayComponentName": "CCTE_Deisenroth_AIME_96WELL_LUC_Active", + "assayComponentDesc": "CCTE_Deisenroth_AIME_96WELL_LUC_Active is one of four assay components measured or calculated from the CCTE_Deisenroth_AIME_96WELL assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "CCTE_Deisenroth_AIME_96WELL_LUC_Active was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Bright-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of estrogen receptor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Luminescence intensity", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ERE linked luciferase reporter enzyme", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 684, + "assayName": "CCTE_Deisenroth_AIME_96WELL", + "assayDesc": "CCTE_Deisenroth_AIME_96WELL (AIME metabolism assay) is a cell-based, single-readout assay that uses VM7Luc4E2, a human mammary gland/breast cell line, with measurements taken at 24 hour after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "mammary gland/breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7Luc4E2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa147", + "url": "https://pubmed.ncbi.nlm.nih.gov/32991717/", + "pmid": 32991717, + "title": "The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence", + "author": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS", + "citation": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS. The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence. Toxicol Sci. 2020 Dec 1;178(2):281-301. doi: 10.1093/toxsci/kfaa147. PMID: 32991717; PMCID: PMC8154005.", + "otherId": "0", + "citationId": 254, + "otherSource": "" + } + }, + { + "aeid": 2485, + "assayComponentEndpointName": "CCTE_Deisenroth_AIME_96WELL_CTox_Active", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "CCTE_Deisenroth_AIME_96WELL_CTox_Active is a component of the CCTE_Deisenroth_AIME_96WELL assay that measures the effect of retroftting the VM7Luc ERTA assay with the Alginate Immobolization of Metabolic Enzymes (AIME) metabolism method. AIME is optimized to impart phase I hepatic metabolism using phenobarbital/beta-naphthoflavone induced hepatic S9 from male Sprague Dawley rats. Parent chemicals are incubated for 2 hours in the AIME assay prior to transfer to the VM7Luc ERTA assay plate. The AIME metabolism assay is run simultaneously in negative (inactive) and positive (active) modes to evaluate the activity of parent and metabolites, respectively. This endpoint evaluates cytotoxicity in metabolism positive mode. Using a type of flourescent probe in VM7Luc cells, loss-of-signal activity can be used to understand loss of viability. This assay endpoint, CCTE_Deisenroth_AIME_96WELL_CTox_Active, was analyzed with bidirectional fitting in the ERTA assay.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2463, + "assayComponentName": "CCTE_Deisenroth_AIME_96WELL_CTox_Active", + "assayComponentDesc": "CCTE_Deisenroth_AIME_96WELL_CTox_Active is one of four assay components measured or calculated from the CCTE_Deisenroth_AIME_96WELL assay. It is designed to make measurements of a protease substrate, a type of viabiliy indicator, as detected with substrate cleavage to a fluorescent probe in living cells.", + "assayComponentTargetDesc": "CCTE_Deisenroth_AIME_96WELL_CTox_Active is designed to make measurements of a protease substrate [Gly-Phe-AFCoumarin], a type of viabiliy indicator. The non-flourescent substrate is enzymatically converted to a fluorescent probe in living cells. Changes in the signal are indicative of cytotoxicity. ", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of estrogen receptor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "protease substrate", + "keyAssayReagent": "Gly-Phe-AFCoumarin", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "fluorogenic probe", + "aid": 684, + "assayName": "CCTE_Deisenroth_AIME_96WELL", + "assayDesc": "CCTE_Deisenroth_AIME_96WELL (AIME metabolism assay) is a cell-based, single-readout assay that uses VM7Luc4E2, a human mammary gland/breast cell line, with measurements taken at 24 hour after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "mammary gland/breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7Luc4E2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa147", + "url": "https://pubmed.ncbi.nlm.nih.gov/32991717/", + "pmid": 32991717, + "title": "The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence", + "author": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS", + "citation": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS. The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence. Toxicol Sci. 2020 Dec 1;178(2):281-301. doi: 10.1093/toxsci/kfaa147. PMID: 32991717; PMCID: PMC8154005.", + "otherId": "0", + "citationId": 254, + "otherSource": "" + } + }, + { + "aeid": 2486, + "assayComponentEndpointName": "CCTE_Deisenroth_AIME_96WELL_LUC_Inactive", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "CCTE_Deisenroth_AIME_96WELL_LUC_Inactive is a component of the CCTE_Deisenroth_AIME_96WELL assay that measures the effect of retroftting the VM7Luc ERTA assay with the Alginate Immobolization of Metabolic Enzymes (AIME) metabolism method. AIME is optimized to impart phase I hepatic metabolism using phenobarbital/beta-naphthoflavone induced hepatic S9 from male Sprague Dawley rats. Parent chemicals are incubated for 2 hours in the AIME assay prior to transfer to the VM7Luc ERTA assay plate. The AIME metabolism assay is run simultaneously in negative (inactive) and positive (active) modes to evaluate the activity of parent and metabolites, respectively. This endpoint evaluates reporter induction in metabolism negative mode. Using a type of inducible reporter in VM7Luc cells, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to xenobiotic metabolism and the gene ESR1. This assay endpoint, CCTE_Deisenroth_AIME_96WELL_LUC_Inactive, was analyzed in the positive analysis fitting direction relative to 17beta-estradiol as the positive control in the ERTA assay. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17beta-estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2464, + "assayComponentName": "CCTE_Deisenroth_AIME_96WELL_LUC_Inactive", + "assayComponentDesc": "CCTE_Deisenroth_AIME_96WELL_LUC_Inactive is one of four assay components measured or calculated from the CCTE_Deisenroth_AIME_96WELL assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "CCTE_Deisenroth_AIME_96WELL_LUC_Inactive was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Bright-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of estrogen receptor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Luminescence intensity", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ERE linked luciferase reporter enzyme", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 684, + "assayName": "CCTE_Deisenroth_AIME_96WELL", + "assayDesc": "CCTE_Deisenroth_AIME_96WELL (AIME metabolism assay) is a cell-based, single-readout assay that uses VM7Luc4E2, a human mammary gland/breast cell line, with measurements taken at 24 hour after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "mammary gland/breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7Luc4E2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa147", + "url": "https://pubmed.ncbi.nlm.nih.gov/32991717/", + "pmid": 32991717, + "title": "The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence", + "author": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS", + "citation": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS. The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence. Toxicol Sci. 2020 Dec 1;178(2):281-301. doi: 10.1093/toxsci/kfaa147. PMID: 32991717; PMCID: PMC8154005.", + "otherId": "0", + "citationId": 254, + "otherSource": "" + } + }, + { + "aeid": 2487, + "assayComponentEndpointName": "CCTE_Deisenroth_AIME_96WELL_CTox_Inactive", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "CCTE_Deisenroth_AIME_96WELL_CTox_Inactive is a component of the CCTE_Deisenroth_AIME_96WELL assay that measures the effect of retroftting the VM7Luc ERTA assay with the Alginate Immobolization of Metabolic Enzymes (AIME) metabolism method. AIME is optimized to impart phase I hepatic metabolism using phenobarbital/beta-naphthoflavone induced hepatic S9 from male Sprague Dawley rats. Parent chemicals are incubated for 2 hours in the AIME assay prior to transfer to the VM7Luc ERTA assay plate. The AIME metabolism assay is run simultaneously in negative (inactive) and positive (active) modes to evaluate the activity of parent and metabolites, respectively. This endpoint evaluates cytotoxicity in metabolism negative mode. Using a type of flourescent probe in VM7Luc cells, loss-of-signal activity can be used to understand loss of viability. This assay endpoint, CCTE_Deisenroth_AIME_96WELL_CTox_Inactive, was analyzed with bidirectional fitting in the ERTA assay.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2465, + "assayComponentName": "CCTE_Deisenroth_AIME_96WELL_CTox_Inactive", + "assayComponentDesc": "CCTE_Deisenroth_AIME_96WELL_CTox_Inactive is one of four assay components measured or calculated from the CCTE_Deisenroth_AIME_96WELL assay. It is designed to make measurements of a protease substrate, a type of viabiliy indicator, as detected with substrate cleavage to a fluorescent probe in living cells.", + "assayComponentTargetDesc": "CCTE_Deisenroth_AIME_96WELL_CTox_Inactive is designed to make measurements of a protease substrate [Gly-Phe-AFCoumarin], a type of viabiliy indicator. The non-flourescent substrate is enzymatically converted to a fluorescent probe in living cells. Changes in the signal are indicative of cytotoxicity. ", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of estrogen receptor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "protease substrate", + "keyAssayReagent": "Gly-Phe-AFCoumarin", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "fluorogenic probe", + "aid": 684, + "assayName": "CCTE_Deisenroth_AIME_96WELL", + "assayDesc": "CCTE_Deisenroth_AIME_96WELL (AIME metabolism assay) is a cell-based, single-readout assay that uses VM7Luc4E2, a human mammary gland/breast cell line, with measurements taken at 24 hour after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "mammary gland/breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7Luc4E2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa147", + "url": "https://pubmed.ncbi.nlm.nih.gov/32991717/", + "pmid": 32991717, + "title": "The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence", + "author": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS", + "citation": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS. The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence. Toxicol Sci. 2020 Dec 1;178(2):281-301. doi: 10.1093/toxsci/kfaa147. PMID: 32991717; PMCID: PMC8154005.", + "otherId": "0", + "citationId": 254, + "otherSource": "" + } + }, + { + "aeid": 2488, + "assayComponentEndpointName": "CCTE_Deisenroth_AIME_384WELL_LUC_Active", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "CCTE_Deisenroth_AIME_384WELL_LUC_Active is a component of the CCTE_Deisenroth_AIME_384WELL assay that measures the effect of retroftting the VM7Luc ERTA assay with the Alginate Immobolization of Metabolic Enzymes (AIME) metabolism method. AIME is optimized to impart phase I hepatic metabolism using phenobarbital/beta-naphthoflavone induced hepatic S9 from male Sprague Dawley rats. Parent chemicals are incubated for 2 hours in the AIME assay prior to transfer to the VM7Luc ERTA assay plate. The AIME metabolism assay is run simultaneously in negative (inactive) and positive (active) modes to evaluate the activity of parent and metabolites, respectively. This endpoint evaluates reporter induction in metabolism positive mode. Using a type of inducible reporter in VM7Luc cells, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to xenobiotic metabolism and the gene ESR1. This assay endpoint, CCTE_Deisenroth_AIME_384WELL_LUC_Active, was analyzed in the positive analysis fitting direction relative to 17beta-estradiol as the positive control in the ERTA assay. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17beta-estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2466, + "assayComponentName": "CCTE_Deisenroth_AIME_384WELL_LUC_Active", + "assayComponentDesc": "CCTE_Deisenroth_AIME_384WELL_LUC_Active is one of four assay components measured or calculated from the CCTE_Deisenroth_AIME_384WELL assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "CCTE_Deisenroth_AIME_384WELL_LUC_Active was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Bright-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of estrogen receptor activity", + "detectionTechnologyType": "Luminescense", + "detectionTechnologyTypeSub": "Luminescence intensity", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ERE linked luciferase reporter enzyme", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 685, + "assayName": "CCTE_Deisenroth_AIME_384WELL", + "assayDesc": "CCTE_Deisenroth_AIME_384WELL (AIME metabolism assay) is a cell-based, single-readout assay that uses VM7Luc4E2, a human mammary gland/breast cell line, with measurements taken at 24 hour after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "mammary gland/breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7Luc4E2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa147", + "url": "https://pubmed.ncbi.nlm.nih.gov/32991717/", + "pmid": 32991717, + "title": "The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence", + "author": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS", + "citation": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS. The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence. Toxicol Sci. 2020 Dec 1;178(2):281-301. doi: 10.1093/toxsci/kfaa147. PMID: 32991717; PMCID: PMC8154005.", + "otherId": "0", + "citationId": 254, + "otherSource": "" + } + }, + { + "aeid": 2489, + "assayComponentEndpointName": "CCTE_Deisenroth_AIME_384WELL_CTox_Active", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "CCTE_Deisenroth_AIME_384WELL_CTox_Active is a component of the CCTE_Deisenroth_AIME_384WELL assay that measures the effect of retroftting the VM7Luc ERTA assay with the Alginate Immobolization of Metabolic Enzymes (AIME) metabolism method. AIME is optimized to impart phase I hepatic metabolism using phenobarbital/beta-naphthoflavone induced hepatic S9 from male Sprague Dawley rats. Parent chemicals are incubated for 2 hours in the AIME assay prior to transfer to the VM7Luc ERTA assay plate. The AIME metabolism assay is run simultaneously in negative (inactive) and positive (active) modes to evaluate the activity of parent and metabolites, respectively. This endpoint evaluates cytotoxicity in metabolism positive mode. Using a type of flourescent probe in VM7Luc cells, loss-of-signal activity can be used to understand loss of viability. This assay endpoint, CCTE_Deisenroth_AIME_384WELL_CTox_Active, was analyzed with bidirectional fitting in the ERTA assay.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2467, + "assayComponentName": "CCTE_Deisenroth_AIME_384WELL_CTox_Active", + "assayComponentDesc": "CCTE_Deisenroth_AIME_384WELL_CTox_Active is one of four assay components measured or calculated from the CCTE_Deisenroth_AIME_384WELL assay. It is designed to make measurements of a protease substrate, a type of viabiliy indicator, as detected with substrate cleavage to a fluorescent probe in living cells.", + "assayComponentTargetDesc": "CCTE_Deisenroth_AIME_384WELL_CTox_Active is designed to make measurements of a protease substrate [Gly-Phe-AFCoumarin], a type of viabiliy indicator. The non-flourescent substrate is enzymatically converted to a fluorescent probe in living cells. Changes in the signal are indicative of cytotoxicity. ", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of estrogen receptor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "protease substrate", + "keyAssayReagent": "Gly-Phe-AFCoumarin", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "fluorogenic probe", + "aid": 685, + "assayName": "CCTE_Deisenroth_AIME_384WELL", + "assayDesc": "CCTE_Deisenroth_AIME_384WELL (AIME metabolism assay) is a cell-based, single-readout assay that uses VM7Luc4E2, a human mammary gland/breast cell line, with measurements taken at 24 hour after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "mammary gland/breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7Luc4E2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa147", + "url": "https://pubmed.ncbi.nlm.nih.gov/32991717/", + "pmid": 32991717, + "title": "The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence", + "author": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS", + "citation": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS. The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence. Toxicol Sci. 2020 Dec 1;178(2):281-301. doi: 10.1093/toxsci/kfaa147. PMID: 32991717; PMCID: PMC8154005.", + "otherId": "0", + "citationId": 254, + "otherSource": "" + } + }, + { + "aeid": 2490, + "assayComponentEndpointName": "CCTE_Deisenroth_AIME_384WELL_LUC_Inactive", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "CCTE_Deisenroth_AIME_384WELL_LUC_Inactive is a component of the CCTE_Deisenroth_AIME_384WELL assay that measures the effect of retroftting the VM7Luc ERTA assay with the Alginate Immobolization of Metabolic Enzymes (AIME) metabolism method. AIME is optimized to impart phase I hepatic metabolism using phenobarbital/beta-naphthoflavone induced hepatic S9 from male Sprague Dawley rats. Parent chemicals are incubated for 2 hours in the AIME assay prior to transfer to the VM7Luc ERTA assay plate. The AIME metabolism assay is run simultaneously in negative (inactive) and positive (active) modes to evaluate the activity of parent and metabolites, respectively. This endpoint evaluates reporter induction in metabolism negative mode. Using a type of inducible reporter in VM7Luc cells, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to xenobiotic metabolism and the gene ESR1. This assay endpoint, CCTE_Deisenroth_AIME_384WELL_LUC_Inactive, was analyzed in the positive analysis fitting direction relative to 17beta-estradiol as the positive control in the ERTA assay. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17beta-estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2468, + "assayComponentName": "CCTE_Deisenroth_AIME_384WELL_LUC_Inactive", + "assayComponentDesc": "CCTE_Deisenroth_AIME_384WELL_LUC_Inactive is one of four assay components measured or calculated from the CCTE_Deisenroth_AIME_384WELL assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "CCTE_Deisenroth_AIME_384WELL_LUC_Inactive was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Bright-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of estrogen receptor activity", + "detectionTechnologyType": "Luminescense", + "detectionTechnologyTypeSub": "Luminescence intensity", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ERE linked luciferase reporter enzyme", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 685, + "assayName": "CCTE_Deisenroth_AIME_384WELL", + "assayDesc": "CCTE_Deisenroth_AIME_384WELL (AIME metabolism assay) is a cell-based, single-readout assay that uses VM7Luc4E2, a human mammary gland/breast cell line, with measurements taken at 24 hour after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "mammary gland/breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7Luc4E2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa147", + "url": "https://pubmed.ncbi.nlm.nih.gov/32991717/", + "pmid": 32991717, + "title": "The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence", + "author": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS", + "citation": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS. The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence. Toxicol Sci. 2020 Dec 1;178(2):281-301. doi: 10.1093/toxsci/kfaa147. PMID: 32991717; PMCID: PMC8154005.", + "otherId": "0", + "citationId": 254, + "otherSource": "" + } + }, + { + "aeid": 2491, + "assayComponentEndpointName": "CCTE_Deisenroth_AIME_384WELL_CTox_Inactive", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "CCTE_Deisenroth_AIME_384WELL_CTox_Inactive is a component of the CCTE_Deisenroth_AIME_384WELL assay that measures the effect of retroftting the VM7Luc ERTA assay with the Alginate Immobolization of Metabolic Enzymes (AIME) metabolism method. AIME is optimized to impart phase I hepatic metabolism using phenobarbital/beta-naphthoflavone induced hepatic S9 from male Sprague Dawley rats. Parent chemicals are incubated for 2 hours in the AIME assay prior to transfer to the VM7Luc ERTA assay plate. The AIME metabolism assay is run simultaneously in negative (inactive) and positive (active) modes to evaluate the activity of parent and metabolites, respectively. This endpoint evaluates cytotoxicity in metabolism negative mode. Using a type of flourescent probe in VM7Luc cells, loss-of-signal activity can be used to understand loss of viability. This assay endpoint, CCTE_Deisenroth_AIME_384WELL_CTox_Inactive, was analyzed with bidirectional fitting in the ERTA assay.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2469, + "assayComponentName": "CCTE_Deisenroth_AIME_384WELL_CTox_Inactive", + "assayComponentDesc": "CCTE_Deisenroth_AIME_384WELL_CTox_Inactive is one of four assay components measured or calculated from the CCTE_Deisenroth_AIME_384WELL assay. It is designed to make measurements of a protease substrate, a type of viabiliy indicator, as detected with substrate cleavage to a fluorescent probe in living cells.", + "assayComponentTargetDesc": "CCTE_Deisenroth_AIME_384WELL_CTox_Inactive is designed to make measurements of a protease substrate [Gly-Phe-AFCoumarin], a type of viabiliy indicator. The non-flourescent substrate is enzymatically converted to a fluorescent probe in living cells. Changes in the signal are indicative of cytotoxicity. ", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of estrogen receptor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "protease substrate", + "keyAssayReagent": "Gly-Phe-AFCoumarin", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "fluorogenic probe", + "aid": 685, + "assayName": "CCTE_Deisenroth_AIME_384WELL", + "assayDesc": "CCTE_Deisenroth_AIME_384WELL (AIME metabolism assay) is a cell-based, single-readout assay that uses VM7Luc4E2, a human mammary gland/breast cell line, with measurements taken at 24 hour after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "mammary gland/breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7Luc4E2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa147", + "url": "https://pubmed.ncbi.nlm.nih.gov/32991717/", + "pmid": 32991717, + "title": "The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence", + "author": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS", + "citation": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS. The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence. Toxicol Sci. 2020 Dec 1;178(2):281-301. doi: 10.1093/toxsci/kfaa147. PMID: 32991717; PMCID: PMC8154005.", + "otherId": "0", + "citationId": 254, + "otherSource": "" + } + }, + { + "aeid": 2492, + "assayComponentEndpointName": "CCTE_Deisenroth_AIME_384WELL_LUC_Shift", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "CCTE_Deisenroth_AIME_384WELL_LUC_Shift is a component of the CCTE_Deisenroth_AIME_384WELL assay that measures the effect of retroftting the VM7Luc ERTA assay with the Alginate Immobolization of Metabolic Enzymes (AIME) metabolism method. AIME is optimized to impart phase I hepatic metabolism using phenobarbital/beta-naphthoflavone induced hepatic S9 from male Sprague Dawley rats. Parent chemicals are incubated for 2 hours in the AIME assay prior to transfer to the VM7Luc ERTA assay plate. The AIME metabolism assay is run simultaneously in negative (inactive) and positive (active) modes to evaluate the activity of parent and metabolites, respectively. This endpoint evaluates the shift in metabolism-dependent changes between positive (active) and negative (inactive) assay modes. The metabolic curve shift response is defined as the pairwise difference between the positive (AEID 2488) and negative (AEID 2490) normalized response values at each concentration for a given chemical across replicate experiments. The pairwise differences form the basis for a concentration-response curve. Standard curve fit analysis identfiied chemicals where the calculated shift was greater than the shift-derived baseline cutoff. A positive hit designation in this endpoint indicates a significant shift trend in the positive direction for bioactivation. ", + "assayFunctionType": "reporter gene", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17beta-estradiol", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2470, + "assayComponentName": "CCTE_Deisenroth_AIME_384WELL_LUC_Shift", + "assayComponentDesc": "CCTE_Deisenroth_AIME_384WELL_LUC_Shift is one of two analysis components calculated from the CCTE_Deisenroth_AIME_384WELL assay. It is designed to evaluate the shift in metabolism-dependent changes of the inducible luciferase reporter between positive (active) and negative (inactive) assay modes.", + "assayComponentTargetDesc": "CCTE_Deisenroth_AIME_384WELL_LUC_Shift was designed to measure the shift in bioluminescence signals produced from an enzymatic reaction involving the key substrate [Bright-Glo]between metabolism positive (active) and negative (inactive) assay modes. Shifts are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372]. Positive shifts are indicative of bioactivation.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of estrogen receptor activity", + "detectionTechnologyType": "Luminescense", + "detectionTechnologyTypeSub": "Luminescence intensity", + "detectionTechnology": "multimode microplate reader", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ERE linked luciferase reporter enzyme", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 685, + "assayName": "CCTE_Deisenroth_AIME_384WELL", + "assayDesc": "CCTE_Deisenroth_AIME_384WELL (AIME metabolism assay) is a cell-based, single-readout assay that uses VM7Luc4E2, a human mammary gland/breast cell line, with measurements taken at 24 hour after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "mammary gland/breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7Luc4E2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa147", + "url": "https://pubmed.ncbi.nlm.nih.gov/32991717/", + "pmid": 32991717, + "title": "The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence", + "author": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS", + "citation": "Deisenroth C, DeGroot DE, Zurlinden T, Eicher A, McCord J, Lee MY, Carmichael P, Thomas RS. The Alginate Immobilization of Metabolic Enzymes Platform Retrofits an Estrogen Receptor Transactivation Assay With Metabolic Competence. Toxicol Sci. 2020 Dec 1;178(2):281-301. doi: 10.1093/toxsci/kfaa147. PMID: 32991717; PMCID: PMC8154005.", + "otherId": "0", + "citationId": 254, + "otherSource": "" + } + }, + { + "aeid": 2494, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_firing_rate_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_firing_rate_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_firing_rate_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2471, + "assayComponentName": "CCTE_Shafer_MEA_dev_firing_rate_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_firing_rate_mean is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the frequency of spikes (action potential firings) as the total number of spikes divided by the length of the recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The firing rate is averaged across the active electrodes to report a well-mean value. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "Mean firing rate is a measure of general activity in the network. Changes in electrical activity are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2496, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_burst_rate", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_burst_rate was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_burst_rate, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2472, + "assayComponentName": "CCTE_Shafer_MEA_dev_burst_rate", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_burst_rate is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the frequency of single-electrode bursts (temporally-clustered groups of action potential firing) as the total number of bursts divided by the length of the recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The mean bursting rate is averaged across the active electrodes to report a well-mean value. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The mean bursting rate is a measure of general activity in the network. Changes in mean burst rate are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2498, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_active_electrodes_number", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_active_electrodes_number was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_active_electrodes_number, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2473, + "assayComponentName": "CCTE_Shafer_MEA_dev_active_electrodes_number", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_active_electrodes_number is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the number of electrodes in a well with a mean firing rate of at least 5 spikes (action potential firings) per minute during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The number of active electrodes is a measure of general activity in the network. Changes in the number of active electrodes are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2500, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_bursting_electrodes_number", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_bursting_electrodes_number was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_bursting_electrodes_number, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2474, + "assayComponentName": "CCTE_Shafer_MEA_dev_bursting_electrodes_number", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_bursting_electrodes_number is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the number of electrodes in a well with a burst rate of at least 1 burst (temporally-clustered group of action potential firing) every 2 minutes during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The number of actively bursting electrodes is a measure of general activity in a network. Changes in the number of actively bursting electrodes are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2502, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_per_burst_interspike_interval", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_per_burst_interspike_interval was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_per_burst_interspike_interval, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: bursting activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2475, + "assayComponentName": "CCTE_Shafer_MEA_dev_per_burst_interspike_interval", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_per_burst_interspike_interval is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the average time interval between spikes (action potential firings) within a single-electrode burst (temporally-clustered group of spikes) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The mean inter-spike interval within bursts is averaged across the actively bursting electrodes to report a well-mean value. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The inter-spike interval within bursts is a measure of bursting activity in the network. Changes in the inter-spike interval within bursts are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2504, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_per_burst_spike_percent", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_per_burst_spike_percent was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_per_burst_spike_percent, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: bursting activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2476, + "assayComponentName": "CCTE_Shafer_MEA_dev_per_burst_spike_percent", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_per_burst_spike_percent is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the percentage of spikes (action potential firings) in a single-electrode burst (temporally-clustered group of spikes) as the total number spikes in bursts divided by the total number of spikes during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The percent of spikes in bursts is averaged across the actively bursting electrodes to report a well-mean value. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The percent of spikes in bursts is a measure of bursting activity in a network. Changes in the percent of spikes in bursts are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2506, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_burst_duration_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_burst_duration_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_burst_duration_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: bursting activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2477, + "assayComponentName": "CCTE_Shafer_MEA_dev_burst_duration_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_burst_duration_mean is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the average time interval from the first spike (action potential firing) to the last spike in a singe-electrode burst (temporally-clustered group of spikes) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The mean burst duration is averaged across the actively bursting electrodes to report a well-mean value. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The mean burst duration is a measure of bursting activity in a network. Changes in the mean burst duration are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2508, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_interburst_interval_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_interburst_interval_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_interburst_interval_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: bursting activity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2478, + "assayComponentName": "CCTE_Shafer_MEA_dev_interburst_interval_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_interburst_interval_mean is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the average time interval between consecutive single-electrode bursts (temporally-clustered groups of action potential firing) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The mean inter-burst interval is averaged across the actively bursting electrodes to report a well-mean value. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The mean inter-burst interval is a measure of bursting activity in a network. Changes in the mean inter-burst interval are indicative of effects on the spontaneous neural activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "spontaneous neural activity ", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2510, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_network_spike_number", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_network_spike_number was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_network_spike_number, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2479, + "assayComponentName": "CCTE_Shafer_MEA_dev_network_spike_number", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_network_spike_number is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the number of network spikes (temporally-clustered groups of action potential firing across multiple electrodes) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The number of network spikes is a measure of the network connectivity. Changes in the number of network spikes are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2512, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_network_spike_peak", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_network_spike_peak was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_network_spike_peak, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2480, + "assayComponentName": "CCTE_Shafer_MEA_dev_network_spike_peak", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_network_spike_peak is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the average number of electrodes participating at the peak of a network spike (the peak of a temporally-clustered group of action potential firing across multiple electrodes) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The network spike peak is a measure of the network connectivity. Changes in the network spike peak are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2514, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_spike_duration_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_spike_duration_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_spike_duration_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2481, + "assayComponentName": "CCTE_Shafer_MEA_dev_spike_duration_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_spike_duration_mean is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the average duration of network spikes (temporally-clustered groups of action potential firing across multiple electrodes) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The mean network spike duration is a measure of the network connectivity. Changes in the mean network spike duration are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 1786, + "assayComponentEndpointName": "ATG_GPCR_MC1R_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_MC1R_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene MC1R. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1055, + "assayComponentName": "ATG_GPCR_MC1R_TRANS", + "assayComponentDesc": "ATG_GPCR_MC1R_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene MC1R, which is responsive to the melanocortin 1 receptor (alpha melanocyte stimulating hormone receptor). [GeneSymbol: MC1R| GeneID: 4157 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "MC1R RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 490, + "geneName": "melanocortin 1 receptor (alpha melanocyte stimulating hormone receptor)", + "description": null, + "geneSymbol": "MC1R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4157, + "officialSymbol": "MC1R", + "officialFullName": "melanocortin 1 receptor (alpha melanocyte stimulating hormone receptor)", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1788, + "assayComponentEndpointName": "ATG_GPCR_MC2R_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_MC2R_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene MC2R. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1056, + "assayComponentName": "ATG_GPCR_MC2R_TRANS", + "assayComponentDesc": "ATG_GPCR_MC2R_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene MC2R, which is responsive to the melanocortin 2 receptor (alpha melanocyte stimulating hormone receptor). [GeneSymbol: MC2R| GeneID: 4158 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "MC2R RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 491, + "geneName": "melanocortin 2 receptor (adrenocorticotropic hormone)", + "description": null, + "geneSymbol": "MC2R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4158, + "officialSymbol": "MC2R", + "officialFullName": "melanocortin 2 receptor (adrenocorticotropic hormone)", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1790, + "assayComponentEndpointName": "ATG_GPCR_MC3R_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_MC3R_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene MC3R. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1057, + "assayComponentName": "ATG_GPCR_MC3R_TRANS", + "assayComponentDesc": "ATG_GPCR_MC3R_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene MC3R, which is responsive to the melanocortin 3 receptor (alpha melanocyte stimulating hormone receptor). [GeneSymbol: MC3R| GeneID: 4159 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "MC3R RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 492, + "geneName": "melanocortin 3 receptor", + "description": null, + "geneSymbol": "MC3R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4159, + "officialSymbol": "MC3R", + "officialFullName": "melanocortin 3 receptor", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1792, + "assayComponentEndpointName": "ATG_GPCR_MC4R_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_MC4R_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene MC4R. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1058, + "assayComponentName": "ATG_GPCR_MC4R_TRANS", + "assayComponentDesc": "ATG_GPCR_MC4R_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene MC4R, which is responsive to the melanocortin 4 receptor (alpha melanocyte stimulating hormone receptor). [GeneSymbol: MC4R| GeneID: 4160 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "MC4R RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 493, + "geneName": "melanocortin 4 receptor", + "description": null, + "geneSymbol": "MC4R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4160, + "officialSymbol": "MC4R", + "officialFullName": "melanocortin 4 receptor", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1794, + "assayComponentEndpointName": "ATG_GPCR_PTGDR_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_PTGDR_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PTGDR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1059, + "assayComponentName": "ATG_GPCR_PTGDR_TRANS", + "assayComponentDesc": "ATG_GPCR_PTGDR_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene PTGDR, which is responsive to the prostaglandin D2 receptor (DP). [GeneSymbol: PTGDR| GeneID: 5729 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "PTGDR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 494, + "geneName": "prostaglandin D2 receptor (DP)", + "description": null, + "geneSymbol": "PTGDR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5729, + "officialSymbol": "PTGDR", + "officialFullName": "prostaglandin D2 receptor (DP)", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1796, + "assayComponentEndpointName": "ATG_GPCR_PTGIR_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_GPCR_PTGIR_TRANS was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PTGIR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "NA", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1060, + "assayComponentName": "ATG_GPCR_PTGIR_TRANS", + "assayComponentDesc": "ATG_GPCR_PTGIR_TRANS is one of 35 assay components measured or calculated from the ATG_GPCR assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene PTGIR, which is responsive to the prostaglandin I2 (prostacyclin) receptor (IP). [GeneSymbol: PTGIR| GeneID: 5739 | Uniprot_SwissProt_Accession: NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "PTGIR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 430, + "assayName": "ATG_GPCR_TRANS", + "assayDesc": "ATG_GPCR is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 495, + "geneName": "prostaglandin I2 (prostacyclin) receptor (IP)", + "description": null, + "geneSymbol": "PTGIR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5739, + "officialSymbol": "PTGIR", + "officialFullName": "prostaglandin I2 (prostacyclin) receptor (IP)", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1797, + "assayComponentEndpointName": "Tanguay_ZF_120hpf_ActivityScore", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component Tanguay_ZF_120hpf_ActivityScore was analyzed into 1 assay endpoints. This assay endpoint, Tanguay_ZF_120hpf_ActivityScore, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphological reporter, gain-of-signal activity can be used to understand changes in developmental defects as they relate to the whole embryo. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the MALFORMATION intended target family, where the subfamily is TOTAL.", + "assayFunctionType": "NA", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "organism", + "intendedTargetTypeSub": "malformation", + "intendedTargetFamily": "malformation", + "intendedTargetFamilySub": "total", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1061, + "assayComponentName": "Tanguay_ZF_120hpf_ActivityScore", + "assayComponentDesc": "Tanguay_ZF_120hpf_ActivityScore is one of one assay component(s) measured or calculated from the Tanguay_ZF_120hpf_ActivityScore assay. It is designed to make measurements of developmental malformations and mortality as detected with brightfield microscopy and combines scoring from 18 other assay components measuring more specific morphologies.", + "assayComponentTargetDesc": "An algorithm was used to combine results from 18 Tanquay_AF_120hpr assay components", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "anatomical entity", + "biologicalProcessTarget": "regulation of morphogenesis", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "embryonic development", + "technologicalTargetTypeSub": "NA", + "aid": 409, + "assayName": "Tanguay_ZF_120hpf", + "assayDesc": "Tanguay_ZF_120hpf is a whole embryo, multiplexed endpoint assay using zebrafish larvae exposed for 120 hr", + "timepointHr": 120.0, + "organismId": 7955, + "organism": "zebrafish", + "tissue": "ova", + "cellFormat": "whole embryo", + "cellFreeComponentSource": "NA", + "cellShortName": "dechorionated zebrafish embryo", + "cellGrowthMode": "suspension", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.7, + "asid": 13, + "assaySourceName": "TANGUAY", + "assaySourceLongName": "Tanguay Lab", + "assaySourceDesc": "The Tanguay Lab, based at the Oregon State University Sinnhuber Aquatic Research Laboratory, uses zebrafish as a systems toxicology model.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kft235", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24136191", + "pmid": 24136191, + "title": "Multidimensional in vivo hazard assessment using zebrafish", + "author": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL", + "citation": "Truong L, Reif DM, St Mary L, Geier MC, Truong HD, Tanguay RL. Multidimensional in vivo hazard assessment using zebrafish. Toxicol Sci. 2014 Jan;137(1):212-33. doi: 10.1093/toxsci/kft235. Epub 2013 Oct 17. PubMed PMID: 24136191; PubMed Central PMCID: PMC3871932.", + "otherId": "0", + "citationId": 220, + "otherSource": "" + } + }, + { + "aeid": 1816, + "assayComponentEndpointName": "TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Nilutamide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1120, + "assayComponentName": "TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881", + "assayComponentDesc": "TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881 is one of one assay component(s) measured or calculated from the TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals following addition of luciferin substrate and ATP.", + "assayComponentTargetDesc": "Androgen receptor (AR) is an important member of the nuclear receptor family. Its signaling plays a critical role in AR-dependent prostate cancer and other androgen related diseases. Considerable attention has been given in the past decades to develop methods to study and screen for the environmental chemicals that have the potential to interfere with metabolic homeostasis, reproduction, developmental and behavioral functions. Changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] are indicative of changes in transcriptional gene expression due to antagonist activity regulated by the human androgen receptor [GeneSymbol:AR | GeneID:367 | Uniprot_SwissProt_Accession:P10275].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 441, + "assayName": "TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881", + "assayDesc": "TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881 is a cell-based, single-readout assay that uses MDA-kb2, a human breast cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MDA-kb2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1016/j.yrtph.2020.104764", + "url": "https://pubmed.ncbi.nlm.nih.gov/32798611/", + "pmid": 32798611, + "title": "Selecting a minimal set of androgen receptor assays for screening chemicals", + "author": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N", + "citation": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N. Selecting a minimal set of androgen receptor assays for screening chemicals. Regul Toxicol Pharmacol. 2020 Nov;117:104764. doi: 10.1016/j.yrtph.2020.104764. Epub 2020 Aug 14. PMID: 32798611; PMCID: PMC8356084.", + "otherId": "0", + "citationId": 283, + "otherSource": "" + } + }, + { + "aeid": 1817, + "assayComponentEndpointName": "TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1121, + "assayComponentName": "TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881_viability", + "assayComponentDesc": "TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 441, + "assayName": "TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881", + "assayDesc": "TOX21_AR_LUC_MDAKB2_Antagonist_0.5nM_R1881 is a cell-based, single-readout assay that uses MDA-kb2, a human breast cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MDA-kb2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1016/j.yrtph.2020.104764", + "url": "https://pubmed.ncbi.nlm.nih.gov/32798611/", + "pmid": 32798611, + "title": "Selecting a minimal set of androgen receptor assays for screening chemicals", + "author": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N", + "citation": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N. Selecting a minimal set of androgen receptor assays for screening chemicals. Regul Toxicol Pharmacol. 2020 Nov;117:104764. doi: 10.1016/j.yrtph.2020.104764. Epub 2020 Aug 14. PMID: 32798611; PMCID: PMC8356084.", + "otherId": "0", + "citationId": 283, + "otherSource": "" + } + }, + { + "aeid": 1818, + "assayComponentEndpointName": "TOX21_RXR_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_RXR_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_RXR_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene RXRA. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "9-cis-Retinoic acid", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1122, + "assayComponentName": "TOX21_RXR_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_RXR_BLA_Agonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_RXR_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to RXRA gene(s) using a positive control of 9-cis-Retinoic acid", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 442, + "assayName": "TOX21_RXR_BLA_Agonist", + "assayDesc": "TOX21_RXR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1819, + "assayComponentEndpointName": "TOX21_RXR_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_RXR_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_RXR_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene RXRA. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "9-cis-Retinoic acid", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1123, + "assayComponentName": "TOX21_RXR_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_RXR_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_RXR_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to RXRA gene(s) using a positive control of 9-cis-Retinoic acid", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 442, + "assayName": "TOX21_RXR_BLA_Agonist", + "assayDesc": "TOX21_RXR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1820, + "assayComponentEndpointName": "TOX21_RXR_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_RXR_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_RXR_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene RXRA. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where subfamily is NF-kappa B.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "9-cis-Retinoic acid", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "NF-kappa B", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1124, + "assayComponentName": "TOX21_RXR_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_RXR_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_RXR_BLA_Agonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to RXRA gene(s) using a positive control of 9-cis-Retinoic acid", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 442, + "assayName": "TOX21_RXR_BLA_Agonist", + "assayDesc": "TOX21_RXR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 287, + "geneName": "retinoid X receptor, alpha", + "description": null, + "geneSymbol": "RXRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6256, + "officialSymbol": "RXRA", + "officialFullName": "retinoid X receptor, alpha", + "uniprotAccessionNumber": "P19793" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1821, + "assayComponentEndpointName": "TOX21_RXR_BLA_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RXR_BLA_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "Cyproterone acetate", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1125, + "assayComponentName": "TOX21_RXR_BLA_Agonist_viability", + "assayComponentDesc": "TOX21_RXR_BLA_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 442, + "assayName": "TOX21_RXR_BLA_Agonist", + "assayDesc": "TOX21_RXR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 1822, + "assayComponentEndpointName": "TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "R1881", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1126, + "assayComponentName": "TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide", + "assayComponentDesc": "TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide is one of one assay component(s) measured or calculated from the TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signal following addition of luciferin substrate and ATP.", + "assayComponentTargetDesc": "TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] in the presence of an AR agonist. Changes are indicative of transcriptional gene expression that may not be due to direct regulation by the human androgen receptor [GeneSymbol: NR3C4 | GeneID: NR3C4 | Uniprot_SwissProt_Accession:].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 443, + "assayName": "TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide", + "assayDesc": "TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide is a cell-based, single-readout assay that uses MDA-kb2, a human breast cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. This is an secondary assay to TOX21_AR_LUC_MDAKB2_Agonist for agonist specificity. This particular screening for measuring luciferase reporter gene activity using MDA-kb2 cells against Tox21 10K library compounds is a confirmation study on agonist mode screening in the presence of AR-antagonist compound (Nilutamide) at 3.0uM final concentration. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MDA-kb2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.yrtph.2020.104764", + "url": "https://pubmed.ncbi.nlm.nih.gov/32798611/", + "pmid": 32798611, + "title": "Selecting a minimal set of androgen receptor assays for screening chemicals", + "author": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N", + "citation": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N. Selecting a minimal set of androgen receptor assays for screening chemicals. Regul Toxicol Pharmacol. 2020 Nov;117:104764. doi: 10.1016/j.yrtph.2020.104764. Epub 2020 Aug 14. PMID: 32798611; PMCID: PMC8356084.", + "otherId": "0", + "citationId": 283, + "otherSource": "" + } + }, + { + "aeid": 1823, + "assayComponentEndpointName": "TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1127, + "assayComponentName": "TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide_viability", + "assayComponentDesc": "TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 443, + "assayName": "TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide", + "assayDesc": "TOX21_AR_LUC_MDAKB2_Agonist_3uM_Nilutamide is a cell-based, single-readout assay that uses MDA-kb2, a human breast cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. This is an secondary assay to TOX21_AR_LUC_MDAKB2_Agonist for agonist specificity. This particular screening for measuring luciferase reporter gene activity using MDA-kb2 cells against Tox21 10K library compounds is a confirmation study on agonist mode screening in the presence of AR-antagonist compound (Nilutamide) at 3.0uM final concentration. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MDA-kb2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1016/j.yrtph.2020.104764", + "url": "https://pubmed.ncbi.nlm.nih.gov/32798611/", + "pmid": 32798611, + "title": "Selecting a minimal set of androgen receptor assays for screening chemicals", + "author": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N", + "citation": "Judson R, Houck K, Paul Friedman K, Brown J, Browne P, Johnston PA, Close DA, Mansouri K, Kleinstreuer N. Selecting a minimal set of androgen receptor assays for screening chemicals. Regul Toxicol Pharmacol. 2020 Nov;117:104764. doi: 10.1016/j.yrtph.2020.104764. Epub 2020 Aug 14. PMID: 32798611; PMCID: PMC8356084.", + "otherId": "0", + "citationId": 283, + "otherSource": "" + } + }, + { + "aeid": 1824, + "assayComponentEndpointName": "CCTE_Simmons_GUA_TPO", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Simmons_GUA_TPO was analyzed at the endpoint, CCTE_Simmons_GUA_TPO, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, measures of enzyme activity for loss-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene TPO. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is peroxidase.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "peroxidase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1128, + "assayComponentName": "CCTE_Simmons_GUA_TPO", + "assayComponentDesc": "CCTE_Simmons_GUA_TPO is the assay component measured from the CCTE_Simmons_GUA_TPO assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by enzyme activity technology. This is an orthogonal assay to CCTE_Simmons_AUR_TPO run for confirmation.", + "assayComponentTargetDesc": "A well-characterized MIE for adverse thyroid-mediated outcomes is inhibition of TPO. TPO catalyzes iodine oxidation in the presence of hydrogen peroxide, regulates nonspecific iodination of tyrosyl residues of thyroglobulin to form TH precursors, monoiodotyrosine (MIT), and diiodotyrosine (DIT), and modulates coupling of these iodotyrosyl residues.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Enzyme activity", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Guaiacol", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 444, + "assayName": "CCTE_Simmons_GUA_TPO", + "assayDesc": "CCTE_Simmons_GUA_TPO is a biochemical, single-readout assay that uses microsomes from porcine thyroid gland in a tissue-based cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 384-well plate.", + "timepointHr": 0.5, + "organismId": 9823, + "organism": "pig", + "tissue": "thyroid gland", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "porcine thyroid gland", + "cellShortName": "", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": { + "geneId": 499, + "geneName": "thyroid peroxidase", + "description": null, + "geneSymbol": "TPO", + "organismId": 5, + "trackStatus": "live", + "entrezGeneId": 445522, + "officialSymbol": "TPO", + "officialFullName": null, + "uniprotAccessionNumber": "P09933" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1021/tx400310w", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24383450", + "pmid": 24383450, + "title": "Development of a thyroperoxidase inhibition assay for high-throughput screening", + "author": "Paul KB, Hedge JM, Rotroff DM, Hornung MW, Crofton KM, Simmons SO", + "citation": "Paul KB, Hedge JM, Rotroff DM, Hornung MW, Crofton KM, Simmons SO. Development of a thyroperoxidase inhibition assay for high-throughput screening. Chem Res Toxicol. 2014 Mar 17;27(3):387-99. doi: 10.1021/tx400310w. Epub 2014 Jan 14. PubMed PMID: 24383450.", + "otherId": "0", + "citationId": 218, + "otherSource": "" + } + }, + { + "aeid": 1825, + "assayComponentEndpointName": "ArunA_CellTiter_hNP", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ArunA_CellTiter_hNP was analyzed at the endpoint, ArunA_CellTiter_hNP, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand the viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cell count", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1129, + "assayComponentName": "ArunA_CellTiter_hNP", + "assayComponentDesc": "ArunA_CellTiter_hNP is an assay component measured from the ArunA_CellTiter_hNP assay. It is designed to make measurements of viability, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to the number of [3H]-thymidine labelled nuceli is indicative of the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurovascular unit NVU development (neurogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "3H-thymidine", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "labelled nuclei", + "aid": 445, + "assayName": "ArunA_CellTiter_hNP", + "assayDesc": "ArunA_CellTiter_hNP is a cell-based, single-readout assay that uses human H9-derived neuroprogenitor stem cells (hNP1).Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "H9-derived neuroprogenitor stem cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "hNP1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 16, + "assaySourceName": "ARUNA", + "assaySourceLongName": "ArunA Biomedical", + "assaySourceDesc": "ArunA Biomedical is a privately owned biotechnology company and Contract Research Organization (CRO) formerly providing toxicology screening using neural stem cell-based assays. ", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 1826, + "assayComponentEndpointName": "ArunA_CellTiter_hNC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ArunA_CellTiter_hNC was analyzed at the endpoint, ArunA_CellTiter_hNC, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cell count", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1130, + "assayComponentName": "ArunA_CellTiter_hNC", + "assayComponentDesc": "ArunA_CellTiter_hNC is an assay component measured from the ArunA_CellTiter_hNC assay. It is designed to make measurements of viability, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to the number of [3H]-thymidine labelled nuceli is indicative of the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurovascular unit NVU development (neurogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "3H-thymidine", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "labelled nuclei", + "aid": 446, + "assayName": "ArunA_CellTiter_hNC", + "assayDesc": "ArunA_CellTiter_hNC is a cell-based, single-readout assay that uses human H9-derived embryonic neural crest stem cells (hNC). Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "H9-derived embryonic neural crest stem cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "hNC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 16, + "assaySourceName": "ARUNA", + "assaySourceLongName": "ArunA Biomedical", + "assaySourceDesc": "ArunA Biomedical is a privately owned biotechnology company and Contract Research Organization (CRO) formerly providing toxicology screening using neural stem cell-based assays. ", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 1827, + "assayComponentEndpointName": "ArunA_Migration_hNP", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ArunA_Migration_hNP was analyzed at the endpoint, ArunA_Migration_hNP, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of distribution reporter, loss-of-signal activity can be used to understand the cell migration. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is migration.", + "assayFunctionType": "developmental", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "cytochalasin D", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "migration", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "migration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1131, + "assayComponentName": "ArunA_Migration_hNP", + "assayComponentDesc": "ArunA_Migration_hNP is an assay component measured from the ArunA_Migration_hNP assay. It is designed to make measurements of cell migration, a form of distribution reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to Ki-67 expression is indicative of the cell migration.", + "parameterReadoutType": "single", + "assayDesignType": "distribution reporter", + "assayDesignTypeSub": "cell migration", + "biologicalProcessTarget": "neurovascular unit NVU development (neurogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Calcein-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "Ki-67", + "aid": 447, + "assayName": "ArunA_Migration_hNP", + "assayDesc": "ArunA_Migration_hNP is a cell-based, single-readout assay that uses human H9-derived neuroprogenitor stem cells (hNP1). Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "H9-derived neuroprogenitor stem cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "hNP1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 16, + "assaySourceName": "ARUNA", + "assaySourceLongName": "ArunA Biomedical", + "assaySourceDesc": "ArunA Biomedical is a privately owned biotechnology company and Contract Research Organization (CRO) formerly providing toxicology screening using neural stem cell-based assays. ", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 1829, + "assayComponentEndpointName": "ArunA_Migration_hNC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ArunA_Migration_hNC was analyzed at the endpoint, ArunA_Migration_hNC, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of distribution reporter, loss-of-signal activity can be used to understand the cell migration. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is migration.", + "assayFunctionType": "developmental", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "cytochalasin D", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "migration", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "migration", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1132, + "assayComponentName": "ArunA_Migration_hNC", + "assayComponentDesc": "ArunA_Migration_hNC is an assay component measured from the ArunA_Migration_hNC assay. It is designed to make measurements of cell migration, a form of distribution reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to Ki-67 expression is indicative of the cell migration.", + "parameterReadoutType": "single", + "assayDesignType": "distribution reporter", + "assayDesignTypeSub": "cell migration", + "biologicalProcessTarget": "neurovascular unit NVU development (neurogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Calcein-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "Ki-67", + "aid": 448, + "assayName": "ArunA_Migration_hNC", + "assayDesc": "ArunA_Migration_hNC is a cell-based, single-readout assay that uses human H9-derived embryonic neural crest stem cells (hNC). Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "H9-derived embryonic neural crest stem cells", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "hNC", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 16, + "assaySourceName": "ARUNA", + "assaySourceLongName": "ArunA Biomedical", + "assaySourceDesc": "ArunA Biomedical is a privately owned biotechnology company and Contract Research Organization (CRO) formerly providing toxicology screening using neural stem cell-based assays. ", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 2516, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_network_spike_duration_std", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_network_spike_duration_std was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_network_spike_duration_std, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2482, + "assayComponentName": "CCTE_Shafer_MEA_dev_network_spike_duration_std", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_network_spike_duration_std is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the standard deviation of the duration of network spikes (temporally-clustered groups of action potential firing across multiple electrodes) during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The standard deviation of network spike duration is a measure of network connectivity. Changes in the standard deviation of network spike duration are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2518, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_inter_network_spike_interval_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_inter_network_spike_interval_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_inter_network_spike_interval_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2483, + "assayComponentName": "CCTE_Shafer_MEA_dev_inter_network_spike_interval_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_inter_network_spike_interval_mean is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the average time interval between network spikes (temporally-clustered groups of actional potential firing across multiple electrodes) as the average time between peaks of consecutive network spikes during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The inter-network spike interval is a measure of the network connectivity. Changes in the inter-network spike interval are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2520, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_per_network_spike_spike_number_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_per_network_spike_spike_number_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_per_network_spike_spike_number_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2484, + "assayComponentName": "CCTE_Shafer_MEA_dev_per_network_spike_spike_number_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_per_network_spike_spike_number_mean is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the average number of spikes (action potential firings) in a network spike (temporally-clustered group of spikes across multiple electrodes) as the number of spikes that occur within a 0.05 s time window at the peak of a network spike divided by the total number of network spikes during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The mean number of spikes in network spikes is a measure of the network connectivity. Changes in the mean number of network spikes are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2522, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_per_network_spike_spike_percent", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_per_network_spike_spike_percent was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_per_network_spike_spike_percent, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2485, + "assayComponentName": "CCTE_Shafer_MEA_dev_per_network_spike_spike_percent", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_per_network_spike_spike_percent is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the percent of spikes (action potential firings) in a network spike (temporally-clustered group of spikes across multiple electrodes) as the number of spikes that occur within a 0.05 s time window at the peak of a network spike divided by the total number of spikes during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "The percent of spikes in network spikes is a measure of the network connectivity. Changes in the percent of spikes in network spikes are indicative of changes in coordinated neural network activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2524, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_correlation_coefficient_mean", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_correlation_coefficient_mean was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_correlation_coefficient_mean, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2486, + "assayComponentName": "CCTE_Shafer_MEA_dev_correlation_coefficient_mean", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_correlation_coefficient_mean is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the correlation coefficent of spikes (action potential firings) between every pair of electrodes in a well during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. The pairwise correlations are averaged across active electrodes to report a well-mean value. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "Electrical activity is captured from neurons cultured over electrodes. Increases in correlation coefficient indicate that the activity of individual neurons in the network is more synchronous, reflecting increased coordination of activity.", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2526, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_mutual_information_norm", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_mutual_information_norm was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_mutual_information_norm, was analyzed in the negative analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of functional reporter, gain or loss-of-signal activity can be used to understand electrical activity.", + "assayFunctionType": "electrical activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "extracellular", + "intendedTargetTypeSub": "action potential", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neural network function: network connectivity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2487, + "assayComponentName": "CCTE_Shafer_MEA_dev_mutual_information_norm", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_mutual_information_norm is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It is a measure of shared information between electrodes during a recording in a microelectrode array (MEA) using Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector. To collapse across multiple recordings made on days post-plating 5, 7, 9 and 12, the trapezoidal area-under-the-curve of the component is calculated.", + "assayComponentTargetDesc": "Normalized Mutual Information is a normalized measure of complexity and synchrony in a network that is robust to changes in network size. It is a scalar (rather than pairwise) measure of mutual information in a multivariate network (See Ball et al., Neural Networks. 2017. 95, 29-43 for further information).", + "parameterReadoutType": "single", + "assayDesignType": "functional reporter", + "assayDesignTypeSub": "electrical activity", + "biologicalProcessTarget": "functional neural network activity", + "detectionTechnologyType": "microelectrode array (MEA)", + "detectionTechnologyTypeSub": "extracellular measurements of action potential “spikes” and groups of spikes, or bursts ", + "detectionTechnology": "Axion Biosystems Maestro 768 channel amplifier with the AxIS adaptive spike detector ", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "electrical activity", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2529, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_LDH", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_LDH was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_LDH, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand cell viability.", + "assayFunctionType": "cell viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2488, + "assayComponentName": "CCTE_Shafer_MEA_dev_LDH", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_LDH is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the lactate dehydrogenase enzyme activity using spectrophotometry.", + "assayComponentTargetDesc": "Changes in enzymatic activity (of lactate dehydrogenase) are indicative of compromised cell health. Reductions in the total LDH (in cells) indicates cell loss or death.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "lactate dehydrogenase activity", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "spectrophotometry", + "detectionTechnologyTypeSub": "absorbance", + "detectionTechnology": "enzyme activity", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "tetrazolium salt", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme: lactate dehydrogenase", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2530, + "assayComponentEndpointName": "CCTE_Shafer_MEA_dev_AB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_dev_AB was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_dev_AB, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand cell viability.", + "assayFunctionType": "cell viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2489, + "assayComponentName": "CCTE_Shafer_MEA_dev_AB", + "assayComponentDesc": "CCTE_Shafer_MEA_dev_AB is 1 of 19 assay components of the CCTE_Shafer_MEA_dev assay. It measures the resazurin reduction using fluorescence.", + "assayComponentTargetDesc": "Changes in enzymatic activity (decrease in mitochondrial enzyme, alamar blue reduction) are indicative of compromised cellular metabolism, possibly indicating cell death.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "mitochondrial enzyme activity", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "resazurin reduction: alamar blue dye converted into fluorescent end product", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "alamar blue (resazurin)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme: mitochondrial enzyme", + "aid": 573, + "assayName": "CCTE_Shafer_MEA_dev", + "assayDesc": "CCTE_Shafer_MEA_dev assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_dev assay uses primary cultures of rat cortical neurons. Recordings are made on days post-plating 5, 7, 9 and 12. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. ", + "timepointHr": 0.25, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO, water, or ethanol", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-017-2035-5", + "url": "https://pubmed.ncbi.nlm.nih.gov/28766123/", + "pmid": 28766123, + "title": "Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates", + "author": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ", + "citation": "Strickland JD, Martin MT, Richard AM, Houck KA, Shafer TJ. Screening the ToxCast phase II libraries for alterations in network function using cortical neurons grown on multi-well microelectrode array (mwMEA) plates. Arch Toxicol. 2018 Jan;92(1):487-500. doi: 10.1007/s00204-017-2035-5. Epub 2017 Aug 2. PMID: 28766123; PMCID: PMC6438628.", + "otherId": "0", + "citationId": 233, + "otherSource": "" + } + }, + { + "aeid": 2532, + "assayComponentEndpointName": "CCTE_GLTED_hDIO2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_GLTED_hDIO2 was analyzed into 1 assay endpoint. This assay endpoint, CCTE_GLTED_hDIO2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene DIO2. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'deiodinase' intended target family, where the subfamily is 'deiodinase Type 2'.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "xanthohumol", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "deiodinase", + "intendedTargetFamilySub": "deiodinase Type 2", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2490, + "assayComponentName": "CCTE_GLTED_hDIO2", + "assayComponentDesc": "CCTE_GLTED_hDIO2 is the assay component measured from the CCTE_GLTED_hDIO2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by spectrophotometry.", + "assayComponentTargetDesc": "Deiodinase enzymes play an essential role in converting thyroid hormones between active and inactive forms by deiodinating the pro-hormone thyroxine (T4) to the active hormone triiodothyronine (T3) and modifying T4 and T3 to inactive forms. DIO2 is important for converting T4 to T3 though the removal of the 5’ outer ring iodine.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Colorimetric", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "thyroxine (T4)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 686, + "assayName": "CCTE_GLTED_hDIO2", + "assayDesc": "CCTE_GLTED_hDIO2 is a cell-free, single-readout assay designed to test the inhibitory activity of chemicals toward human iodothyronine Deiodinase type 2 (DIO2) enzyme. Enzyme is incubated in presence of test chemical for 3 hours during which uninhibited enzyme liberates free iodide from substrate. Free iodide is measured in a second step using the Sandell-Kolthoff method.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "HEK293", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 24, + "assaySourceName": "CCTE_GLTED", + "assaySourceLongName": "CCTE Great Lakes Toxicology and Ecology Division", + "assaySourceDesc": "The EPA CCTE Great Lakes Toxicology and Ecology Division focuses on ecotoxicology and stressors of water resources, including devleopment and implementation of in vitro and in vivo assays.", + "gene": { + "geneId": 2790, + "geneName": "iodothyronine deiodinase 2", + "description": null, + "geneSymbol": "DIO2", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 1734, + "officialSymbol": "DIO2", + "officialFullName": "iodothyronine deiodinase 2", + "uniprotAccessionNumber": null + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfx27", + "url": "https://pubmed.ncbi.nlm.nih.gov/29228274/", + "pmid": 29228274, + "title": "Screening the ToxCast Phase 1 Chemical Library for Inhibition of Deiodinase Type 1 Activity", + "author": "Hornung MW, Korte JJ, Olker JH, Denny JS, Knutsen C, Hartig PC, Cardon MC, Degitz SJ", + "citation": "Hornung MW, Korte JJ, Olker JH, Denny JS, Knutsen C, Hartig PC, Cardon MC, Degitz SJ. Screening the ToxCast Phase 1 Chemical Library for Inhibition of Deiodinase Type 1 Activity. Toxicol Sci. 2018 Apr 1;162(2):570-581. doi: 10.1093/toxsci/kfx279. PMID: 29228274; PMCID: PMC6639810.", + "otherId": "0", + "citationId": 238, + "otherSource": "" + } + }, + { + "aeid": 198, + "assayComponentEndpointName": "BSK_BE3C_SRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_SRB was analyzed into 1 assay endpoint. This assay endpoint, BSK_BE3C_SRB, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is cell conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 140, + "assayComponentName": "BSK_BE3C_SRB", + "assayComponentDesc": "BSK_BE3C_SRB is an assay component measured in the BSK_BE3C assay. It measures 0.1% sulforhodamine related to cell death using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "SRB in the BE3C system is a measure of the total protein content of bronchial epithelial cells. Cell viability of adherent cells is measured by Sulforhodamine B (SRB) staining, a method that determines cell density by measuring total protein content of test wells.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 2533, + "assayComponentEndpointName": "CCTE_GLTED_hDIO3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_GLTED_hDIO3 was analyzed into 1 assay endpoint. This assay endpoint, CCTE_GLTED_hDIO3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene DIO3. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the 'deiodinase' intended target family, where the subfamily is 'deiodinase Type 3'.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "xanthohumol", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "deiodinase", + "intendedTargetFamilySub": "deiodinase Type 3", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2491, + "assayComponentName": "CCTE_GLTED_hDIO3", + "assayComponentDesc": "CCTE_GLTED_hDIO3 is the assay component measured from the CCTE_GLTED_hDIO3 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by spectrophotometry.", + "assayComponentTargetDesc": "Deiodinase enzymes play an essential role in converting thyroid hormones between active and inactive forms by deiodinating the pro-hormone thyroxine (T4) to the active hormone triiodothyronine (T3) and modifying T4 and T3 to inactive forms. DIO3 inactivates both T4 and T3 by removing an inner ring iodine, producing reverse T3 (rT3) and diiodotyrosine (T2), respectively.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Colorimetric", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "3,3'5-triiodothyronine (T3)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 687, + "assayName": "CCTE_GLTED_hDIO3", + "assayDesc": "CCTE_GLTED_hDIO3 is a cell-free, single-readout assay designed to test the inhibitory activity of chemicals toward human iodothyronine Deiodinase type 3 (DIO3) enzyme. Enzyme is incubated in presence of test chemical for 3 hours during which uninhibited enzyme liberates free iodide from substrate. Free iodide is measured in a second step using the Sandell-Kolthoff method.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "HEK293", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 24, + "assaySourceName": "CCTE_GLTED", + "assaySourceLongName": "CCTE Great Lakes Toxicology and Ecology Division", + "assaySourceDesc": "The EPA CCTE Great Lakes Toxicology and Ecology Division focuses on ecotoxicology and stressors of water resources, including devleopment and implementation of in vitro and in vivo assays.", + "gene": { + "geneId": 2791, + "geneName": "iodothyronine deiodinase 3", + "description": null, + "geneSymbol": "DIO3", + "organismId": 1, + "trackStatus": null, + "entrezGeneId": 1735, + "officialSymbol": "DIO3", + "officialFullName": "iodothyronine deiodinase 3", + "uniprotAccessionNumber": null + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfx27", + "url": "https://pubmed.ncbi.nlm.nih.gov/29228274/", + "pmid": 29228274, + "title": "Screening the ToxCast Phase 1 Chemical Library for Inhibition of Deiodinase Type 1 Activity", + "author": "Hornung MW, Korte JJ, Olker JH, Denny JS, Knutsen C, Hartig PC, Cardon MC, Degitz SJ", + "citation": "Hornung MW, Korte JJ, Olker JH, Denny JS, Knutsen C, Hartig PC, Cardon MC, Degitz SJ. Screening the ToxCast Phase 1 Chemical Library for Inhibition of Deiodinase Type 1 Activity. Toxicol Sci. 2018 Apr 1;162(2):570-581. doi: 10.1093/toxsci/kfx279. PMID: 29228274; PMCID: PMC6639810.", + "otherId": "0", + "citationId": 238, + "otherSource": "" + } + }, + { + "aeid": 2540, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_LDH", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_LDH was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_LDH, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain-of-signal activity can be used to understand cell viability.", + "assayFunctionType": "cell viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tritonx100", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2495, + "assayComponentName": "CCTE_Shafer_MEA_acute_LDH", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_LDH is a component of the CCTE_Shafer_MEA_acute assay. It measures the lactate dehydrogenase enzyme activity using spectrophotometry.", + "assayComponentTargetDesc": "Changes in enzymatic activity (increase in lactate dehydrogenase) are indicative of compromised cell health. Increases in extracellular LDH indicate cell loss or death.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "lactate dehydrogenase activity", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "spectrophotometry", + "detectionTechnologyTypeSub": "absorbance", + "detectionTechnology": "enzyme activity", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "tetrazolium salt", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme: lactate dehydrogenase", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2541, + "assayComponentEndpointName": "CCTE_Shafer_MEA_acute_AB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Shafer_MEA_acute_AB was analyzed into 1 assay endpoint. This assay endpoint, CCTE_Shafer_MEA_acute_AB, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand cell viability.", + "assayFunctionType": "cell viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2496, + "assayComponentName": "CCTE_Shafer_MEA_acute_AB", + "assayComponentDesc": "CCTE_Shafer_MEA_acute_AB is a component of the CCTE_Shafer_MEA_acute assay. It measures the resazurin reduction using fluorescence.", + "assayComponentTargetDesc": "Changes in enzymatic activity (decrease in mitochondrial enzyme, alamar blue reduction) are indicative of compromised cellular metabolism, possibly indicating cell death.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "mitochondrial enzyme activity", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "fluorescence", + "detectionTechnologyTypeSub": "fluorescence intensity", + "detectionTechnology": "resazurin reduction: alamar blue dye converted into fluorescent end product", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "alamar blue (resazurin)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme: mitochondrial enzyme", + "aid": 877, + "assayName": "CCTE_Shafer_MEA_acute", + "assayDesc": "CCTE_Shafer_MEA_acute assay is conducted using Axion Biosystems 48 well microelectrode array (MEA) plates and Maestro recording system. Each well of the MEA plate contains a grid of 16 microelectrodes embedded in the culture surface. Electrically active cells, such as neurons, can be cultured over the electrodes, and electrical activity in these cells can be recorded extracellularly. The spontaneous firing of neurons is captured from each electrode on a microsecond timescale providing both temporally and spatially precise data. Because the recordings do not impact the health of the cells, multiple recordings can be made from the same neural network over time in culture. The CCTE_Shafer_MEA_acute assay uses primary cultures of rat cortical neurons. As these cultures mature over time, neural networks develop functional activity and form cohesive networks in which electrical activity can be highly coordinated. Baseline 40-minute recordings are made on days post-plating 13 or 15, followed by a secondary 40-minute recording after chemical exposure.", + "timepointHr": 0.666666666666667, + "organismId": 10116, + "organism": "rat", + "tissue": "cortical", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "primary cortical cell culture", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO or water", + "dilutionSolventPercentMax": 0.2, + "asid": 20, + "assaySourceName": "CCTE_SHAFER", + "assaySourceLongName": "CCTE Shafer Lab", + "assaySourceDesc": "The Shafer lab at the EPA Center for Computational Toxicology and Exposure focus on developmental neurotoxicity (DNT) hazard identificaton using microelectrode array (MEA) assays.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 2545, + "assayComponentEndpointName": "UKN5_HCS_SBAD2_neurite_outgrowth", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint UKN5_HCS_SBAD2_neurite_outgrowth was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, gain or loss-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is neurite outgrowth.", + "assayFunctionType": "developmental", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Narciclasine", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2500, + "assayComponentName": "UKN5_HCS_SBAD2_neurite_outgrowth", + "assayComponentDesc": "UKN5_HCS_SBAD2_neurite_outgrowth is an assay component measured from the UKN5_HCS_SBAD2 assay. It is designed to make measurements of neurite outgrowth, a form of morphology reporter, as detected with Fluorescence intensity signals by HCS Fluorescent Imaging.", + "assayComponentTargetDesc": "Changes in the neurite area are indicative of neurodevelopment.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurodevelopment", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain;stain", + "keyAssayReagent": "calcein-AM; Hoechst 33339", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "neurite area", + "aid": 691, + "assayName": "UKN5_HCS_SBAD2", + "assayDesc": "UKN5_HCS_SBAD2 is a cell-based, multiplexed-readout assay screening for neurite outgrowth and cell viability that uses SBAD2 (peripheral neurons differentiated from iPSC), a human peripheral nervous system cell line, with measurements taken at 3 hours after chemical dosing in a microplate: 96-well plate. UKN5, also referred to as PeriTox, is an assay that uses human iPSC line SBAD2 as a model of peripheral neurons. Following 24 hr chemical exposures in multi-well plates, neurite area is evaluated as a marker of neurite outgrowth using high-content imaging of cells stained with calcein-AM. Cell viability is assessed using stain Hoechst H-33342.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "peripheral nervous system", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "SBAD2 (peripheral neurons differentiated from iPSC)", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 27, + "assaySourceName": "UKN", + "assaySourceLongName": "University of Konstanz", + "assaySourceDesc": "The Leist research group at the University of Konstanz conducts high content imaging assays for neurotoxicity.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-013-1072-y", + "url": "https://pubmed.ncbi.nlm.nih.gov/23670202/", + "pmid": 23670202, + "title": "Evaluation of a human neurite growth assay as specific screen for developmental neurotoxicants", + "author": "Krug AK, Balmer NV, Matt F, Schönenberger F, Merhof D, Leist M", + "citation": "Krug AK, Balmer NV, Matt F, Schönenberger F, Merhof D, Leist M. Evaluation of a human neurite growth assay as specific screen for developmental neurotoxicants. Arch Toxicol. 2013 Dec;87(12):2215-31. doi: 10.1007/s00204-013-1072-y. Epub 2013 May 14. PMID: 23670202.", + "otherId": "0", + "citationId": 278, + "otherSource": "" + } + }, + { + "aeid": 535, + "assayComponentEndpointName": "NVS_ENZ_hPTPN13", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPN13 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPN13, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPN13. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is non-receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "non-receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 309, + "assayComponentName": "NVS_ENZ_hPTPN13", + "assayComponentDesc": "NVS_ENZ_hPTPN13 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPN13 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein tyrosine phosphatase, non-receptor type 13 (APO-1/CD95 (Fas)-associated phosphatase) [GeneSymbol:PTPN13 | GeneID:5783 | Uniprot_SwissProt_Accession:Q12923].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 123, + "assayName": "NVS_ENZ_hPTPN13", + "assayDesc": "NVS_ENZ_hPTPN13 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 384-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 272, + "geneName": "protein tyrosine phosphatase, non-receptor type 13 (APO-1/CD95 (Fas)-associated phosphatase)", + "description": null, + "geneSymbol": "PTPN13", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5783, + "officialSymbol": "PTPN13", + "officialFullName": "protein tyrosine phosphatase, non-receptor type 13 (APO-1/CD95 (Fas)-associated phosphatase)", + "uniprotAccessionNumber": "Q12923" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 1831, + "assayComponentEndpointName": "ArunA_NOG_NucleusCount", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ArunA_NOG_NucleusCount was analyzed at the endpoint, ArunA_NOG_NucleusCount, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand viability. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is neurite outgrowth.", + "assayFunctionType": "developmental", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cell count", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1133, + "assayComponentName": "ArunA_NOG_NucleusCount", + "assayComponentDesc": "ArunA_NOG_NucleusCount is an assay component measured from the ArunA_NOG assay. It is designed to make measurements of viability related to the number of neurons, using a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to the number of Hoechst 33,258 labelled nuceli is indicative of the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "neurovascular unit NVU development (neurogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst-33258 dye", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "labelled nuclei", + "aid": 449, + "assayName": "ArunA_NOG", + "assayDesc": "ArunA_NOG (Neurite Outgrowth) is a cell-based, image-based assay that uses human H9-derived embryonic differentiated neurons (hNN). Measurements were taken 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "H9-derived embryonic differentiated neurons", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "hNN", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 16, + "assaySourceName": "ARUNA", + "assaySourceLongName": "ArunA Biomedical", + "assaySourceDesc": "ArunA Biomedical is a privately owned biotechnology company and Contract Research Organization (CRO) formerly providing toxicology screening using neural stem cell-based assays. ", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 1833, + "assayComponentEndpointName": "ArunA_NOG_NeuriteLength", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ArunA_NOG_NeuriteLength was analyzed at the endpoint, ArunA_NOG_NeuriteLength, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is neurite outgrowth.", + "assayFunctionType": "developmental", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "morphology", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1134, + "assayComponentName": "ArunA_NOG_NeuriteLength", + "assayComponentDesc": "ArunA_NOG_NeuriteLength is an assay component measured from the ArunA_NOG assay. It is designed to make measurements of neurite outgrowth related to neurite length, using a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to bIII-tubulin/DyLight1 488 antibody labelling is indicative of the neurite outgrowth.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurovascular unit NVU development (neurogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "bIII-tubulin/DyLight1 488 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "neurite length", + "aid": 449, + "assayName": "ArunA_NOG", + "assayDesc": "ArunA_NOG (Neurite Outgrowth) is a cell-based, image-based assay that uses human H9-derived embryonic differentiated neurons (hNN). Measurements were taken 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "H9-derived embryonic differentiated neurons", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "hNN", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 16, + "assaySourceName": "ARUNA", + "assaySourceLongName": "ArunA Biomedical", + "assaySourceDesc": "ArunA Biomedical is a privately owned biotechnology company and Contract Research Organization (CRO) formerly providing toxicology screening using neural stem cell-based assays. ", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 1835, + "assayComponentEndpointName": "ArunA_NOG_NeuritesPerNeuron", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ArunA_NOG_NeuritesPerNeuron was analyzed at the endpoint, ArunA_NOG_NeuritesPerNeuron, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, loss-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is neurite outgrowth.", + "assayFunctionType": "developmental", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "morphology", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1135, + "assayComponentName": "ArunA_NOG_NeuritesPerNeuron", + "assayComponentDesc": "ArunA_NOG_NeuritesPerNeuron is an assay component measured from the ArunA_NOG assay. It is designed to make measurements of neurite outgrowth related to number of neurites per neuron, using a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to bIII-tubulin/DyLight1 488 antibody labelling is indicative of the neurite outgrowth.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurovascular unit NVU development (neurogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "bIII-tubulin/DyLight1 488 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "neurites per neuron", + "aid": 449, + "assayName": "ArunA_NOG", + "assayDesc": "ArunA_NOG (Neurite Outgrowth) is a cell-based, image-based assay that uses human H9-derived embryonic differentiated neurons (hNN). Measurements were taken 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "H9-derived embryonic differentiated neurons", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "hNN", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 16, + "assaySourceName": "ARUNA", + "assaySourceLongName": "ArunA Biomedical", + "assaySourceDesc": "ArunA Biomedical is a privately owned biotechnology company and Contract Research Organization (CRO) formerly providing toxicology screening using neural stem cell-based assays. ", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 1838, + "assayComponentEndpointName": "ArunA_NOG_BranchPointsPerNeurite", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ArunA_NOG_BranchPointsPerNeurite was analyzed at the endpoint, ArunA_NOG_BranchPointsPerNeurite, with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of morphology reporter, gain-of-signal activity can be used to understand developmental effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the neurodevelopment intended target family, where the subfamily is neurite outgrowth.", + "assayFunctionType": "developmental", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "morphology", + "intendedTargetFamily": "neurodevelopment", + "intendedTargetFamilySub": "neurite outgrowth", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1136, + "assayComponentName": "ArunA_NOG_BranchPointsPerNeurite", + "assayComponentDesc": "ArunA_NOG_BranchPointsPerNeurite is an assay component measured from the ArunA_NOG assay. It is designed to make measurements of neurite outgrowth related to branch points per neurite, using a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology. ", + "assayComponentTargetDesc": "Changes in fluorescence intensity related to bIII-tubulin/DyLight1 488 antibody labelling is indicative of the neurite outgrowth.", + "parameterReadoutType": "multiple", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "neurite outgrowth", + "biologicalProcessTarget": "neurovascular unit NVU development (neurogenic outcomes)", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "bIII-tubulin/DyLight1 488 antibody", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "branch points per neurite", + "aid": 449, + "assayName": "ArunA_NOG", + "assayDesc": "ArunA_NOG (Neurite Outgrowth) is a cell-based, image-based assay that uses human H9-derived embryonic differentiated neurons (hNN). Measurements were taken 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "H9-derived embryonic differentiated neurons", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "hNN", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "image-based", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 16, + "assaySourceName": "ARUNA", + "assaySourceLongName": "ArunA Biomedical", + "assaySourceDesc": "ArunA Biomedical is a privately owned biotechnology company and Contract Research Organization (CRO) formerly providing toxicology screening using neural stem cell-based assays. ", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.reprotox.2020.06.010", + "url": "https://pubmed.ncbi.nlm.nih.gov/32590145/", + "pmid": 32590145, + "title": " A cross-platform approach to characterize and screen potential neurovascular unit toxicants", + "author": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Baker NC, Toimela T, Heinonen T, Knudsen TB. A cross-platform approach to characterize and screen potential neurovascular unit toxicants. Reprod Toxicol. 2020 Jun 24;96:300-315. doi: 10.1016/j.reprotox.2020.06.010. Epub ahead of print. PMID: 32590145.", + "otherId": "0", + "citationId": 250, + "otherSource": "" + } + }, + { + "aeid": 2552, + "assayComponentEndpointName": "ERF_CR_ADME_hCYP2C19_Omeprazole", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ADME_hCYP2C19_Omeprazole was analyzed at the assay endpoint, ERF_CR_ADME_hCYP2C19_Omeprazole, in the positive analysis fitting direction relative to acetonitrile as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CYP2C19. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is steroidogenesis-related.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp ", + "intendedTargetFamilySub": "steroidogenesis-related", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2505, + "assayComponentName": "ERF_CR_ADME_hCYP2C19_Omeprazole", + "assayComponentDesc": "ERF_CR_ADME_hCYP2C19_Omeprazole is an assay component calculated from the ERF_CR_ADME_hCYP2C19_Omeprazole assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by peak area response of 5-hydroxyomeprazole with HPLC-MS/MS technology.", + "assayComponentTargetDesc": "Changes in peak area response of 5-hydroxyomeprazole produced from the regulation of catalytic activity reaction involving the key substrate, omeprazole, are indicative of changes in enzyme function and kinetics related to the gene CYP2C19.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Mass spectrometry", + "detectionTechnologyTypeSub": "Peak intensity", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "omeprazole", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 728, + "assayName": "ERF_CR_ADME_hCYP2C19_Omeprazole", + "assayDesc": "ERF_CR_ADME_hCYP2C19_Omeprazole is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.16 hour after chemical dosing in a 96-well plate. See CYP2C19 inhibition (HLM, omeprazole substrate).", + "timepointHr": 0.16, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human liver microsomes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 83, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "description": null, + "geneSymbol": "CYP2C19", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1557, + "officialSymbol": "CYP2C19", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "uniprotAccessionNumber": "P33261" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2553, + "assayComponentEndpointName": "ERF_CR_ADME_hCYP2C8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ADME_hCYP2C8 was analyzed at the assay endpoint, ERF_CR_ADME_hCYP2C8, in the positive analysis fitting direction relative to acetonitrile as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CYP2C8. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is steroidogenesis-related.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp ", + "intendedTargetFamilySub": "steroidogenesis-related", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2506, + "assayComponentName": "ERF_CR_ADME_hCYP2C8", + "assayComponentDesc": "ERF_CR_ADME_hCYP2C8 is an assay component calculated from the ERF_CR_ADME_hCYP2C8 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by peak area response of desethylamodiaquine with HPLC-MS/MS technology.", + "assayComponentTargetDesc": "Changes in peak area response of desethylamodiaquine produced from the regulation of catalytic activity reaction involving the key substrate, amodiaquine, are indicative of changes in enzyme function and kinetics related to the gene CYP2C8.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Mass spectrometry", + "detectionTechnologyTypeSub": "Peak intensity", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "amodiaquine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 821, + "assayName": "ERF_CR_ADME_hCYP2C8", + "assayDesc": "ERF_CR_ADME_hCYP2C8 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.16 hour after chemical dosing in a 96-well plate. See CYP2C8 inhibition (HLM, amodiaquine substrate).", + "timepointHr": 0.16, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human liver microsomes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 84, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 8", + "description": null, + "geneSymbol": "CYP2C8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1558, + "officialSymbol": "CYP2C8", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 8", + "uniprotAccessionNumber": "P10632" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2554, + "assayComponentEndpointName": "ERF_CR_ADME_hCYP2C9", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ADME_hCYP2C9 was analyzed at the assay endpoint, ERF_CR_ADME_hCYP2C9, in the positive analysis fitting direction relative to acetonitrile as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CYP2C9. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is steroidogenesis-related.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp ", + "intendedTargetFamilySub": "steroidogenesis-related", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2507, + "assayComponentName": "ERF_CR_ADME_hCYP2C9", + "assayComponentDesc": "ERF_CR_ADME_hCYP2C9 is an assay component calculated from the ERF_CR_ADME_hCYP2C9 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity of HFC with fluorimetry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity of HFC produced from the regulation of catalytic activity reaction involving the key substrate, 7-methoxy-4-trifluoromethylcoumarin (MFC), are indicative of changes in enzyme function and kinetics related to the gene CYP2C9.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorimetry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-methoxy-4-trifluoromethylcoumarin (MFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 815, + "assayName": "ERF_CR_ADME_hCYP2C9", + "assayDesc": "ERF_CR_ADME_hCYP2C9 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.66 hour after chemical dosing in a 96-well plate. See CYP2C9 inhibition (recombinant, MFC substrate).", + "timepointHr": 0.66, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cyp", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 85, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 9", + "description": null, + "geneSymbol": "CYP2C9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1559, + "officialSymbol": "CYP2C9", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 9", + "uniprotAccessionNumber": "P11712" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2555, + "assayComponentEndpointName": "ERF_CR_ADME_hCYP2E1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ADME_hCYP2E1 was analyzed at the assay endpoint, ERF_CR_ADME_hCYP2E1, in the positive analysis fitting direction relative to acetonitrile as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CYP2E1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is steroidogenesis-related.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp ", + "intendedTargetFamilySub": "steroidogenesis-related", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2508, + "assayComponentName": "ERF_CR_ADME_hCYP2E1", + "assayComponentDesc": "ERF_CR_ADME_hCYP2E1 is an assay component calculated from the ERF_CR_ADME_hCYP2E1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by peak area response of 6-hydroxychlorzoxazone with HPLC-MS/MS technology.", + "assayComponentTargetDesc": "Changes in peak area response of 6-hydroxychlorzoxazone produced from the regulation of catalytic activity reaction involving the key substrate, Chlorzoxazone, are indicative of changes in enzyme function and kinetics related to the gene CYP2E1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Mass spectrometry", + "detectionTechnologyTypeSub": "Peak intensity", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Chlorzoxazone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 743, + "assayName": "ERF_CR_ADME_hCYP2E1", + "assayDesc": "ERF_CR_ADME_hCYP2E1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.16 hour after chemical dosing in a 96-well plate. See CYP2E1 inhibition (recombinant, EC substrate).", + "timepointHr": 0.16, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human liver microsomes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 88, + "geneName": "cytochrome P450, family 2, subfamily E, polypeptide 1", + "description": null, + "geneSymbol": "CYP2E1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1571, + "officialSymbol": "CYP2E1", + "officialFullName": "cytochrome P450, family 2, subfamily E, polypeptide 1", + "uniprotAccessionNumber": "P05181" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1839, + "assayComponentEndpointName": "TOX21_RAR_LUC_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_RAR_LUC_Antagonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_RAR_LUC_Antagonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene RARA. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where subfamily is non-steroidal.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "ER50891", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1137, + "assayComponentName": "TOX21_RAR_LUC_Antagonist", + "assayComponentDesc": "TOX21_RAR_LUC_Antagonist is one of one assay component(s) measured or calculated from the TOX21_RAR_LUC_Antagonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology", + "assayComponentTargetDesc": "TOX21_RAR_LUC_Antagonist was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human retinoic acid receptor alpha [GeneSymbol:RARA]", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 450, + "assayName": "TOX21_RAR_LUC_Antagonist", + "assayDesc": "TOX21_RAR_LUC_Antagonist is a cell-based, single-readout assay that uses C3H10T1/2, a mouse sarcoma cell line, with measurements taken at 6 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 6.0, + "organismId": 10090, + "organism": "mouse", + "tissue": "embryo", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "C3H10T1/2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 279, + "geneName": "retinoic acid receptor, alpha", + "description": null, + "geneSymbol": "RARA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5914, + "officialSymbol": "RARA", + "officialFullName": "retinoic acid receptor, alpha", + "uniprotAccessionNumber": "P10276" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1840, + "assayComponentEndpointName": "TOX21_RAR_LUC_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_RAR_LUC_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1138, + "assayComponentName": "TOX21_RAR_LUC_Antagonist_viability", + "assayComponentDesc": "TOX21_RAR_LUC_Antagonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 450, + "assayName": "TOX21_RAR_LUC_Antagonist", + "assayDesc": "TOX21_RAR_LUC_Antagonist is a cell-based, single-readout assay that uses C3H10T1/2, a mouse sarcoma cell line, with measurements taken at 6 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 6.0, + "organismId": 10090, + "organism": "mouse", + "tissue": "embryo", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "C3H10T1/2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 1841, + "assayComponentEndpointName": "TOX21_H2AX_HTRF_CHO_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_H2AX_HTRF_CHO_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_H2AX_HTRF_CHO_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene H2AFX. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Etoposide", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1139, + "assayComponentName": "TOX21_H2AX_HTRF_CHO_Agonist_ch1", + "assayComponentDesc": "TOX21_H2AX_HTRF_CHO_Agonist_ch1 is an assay readout measuring protein phosphorylation and designed using homogenous time resolved fluorescence between two labled antibodies. The signal is derived from the donor (Europium-cryptate) antibody emission and is used to calculate the ratio of acceptor (d2) emission (ch2) to donor emission (ch1) used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_H2AX_HTRF_CHO_Agonist_ch1 was designed to measure donor labeled antibody emission to target protein phosphorylation, specifically mapping to H2AFX gene(s) using a positive control of Etoposide", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "detection of DNA damage", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Homogeneous Time Resolved Fluorescence", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "H2AX antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 451, + "assayName": "TOX21_H2AX_HTRF_CHO_Agonist", + "assayDesc": "TOX21_H2AX_HTRF_CHO_Agonist is a cell-based, single-readout assay that uses CHO-K1, a chinese hamster ovary cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 10029, + "organism": "chinese hamster", + "tissue": "ovary", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "CHO-K1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1842, + "assayComponentEndpointName": "TOX21_H2AX_HTRF_CHO_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_H2AX_HTRF_CHO_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_H2AX_HTRF_CHO_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene H2AFX. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Etoposide", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1140, + "assayComponentName": "TOX21_H2AX_HTRF_CHO_Agonist_ch2", + "assayComponentDesc": "TOX21_H2AX_HTRF_CHO_Agonist_ch2 is an assay readout measuring protein phosphorylation and designed using homogenous time resolved fluorescence between two labled antibodies. The signal is derived from the acceptor (d2) antibody emission and is used to calculate the ratio of acceptor emission (ch2) to donor emission (ch1) used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_H2AX_HTRF_CHO_Agonist_ch2 was designed to measure acceptor labeled antibody emission to target protein phosphorylation, specifically mapping to H2AFX gene(s) using a positive control of Etoposide", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Homogeneous Time Resolved Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 451, + "assayName": "TOX21_H2AX_HTRF_CHO_Agonist", + "assayDesc": "TOX21_H2AX_HTRF_CHO_Agonist is a cell-based, single-readout assay that uses CHO-K1, a chinese hamster ovary cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 10029, + "organism": "chinese hamster", + "tissue": "ovary", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "CHO-K1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 2556, + "assayComponentEndpointName": "ERF_CR_ADME_hCYP3A4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ADME_hCYP3A4 was analyzed at the assay endpoint, ERF_CR_ADME_hCYP3A4, in the positive analysis fitting direction relative to acetonitrile as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CYP3A4. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is steroidogenesis-related.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp ", + "intendedTargetFamilySub": "steroidogenesis-related", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2509, + "assayComponentName": "ERF_CR_ADME_hCYP3A4", + "assayComponentDesc": "ERF_CR_ADME_hCYP3A4 is an assay component calculated from the ERF_CR_ADME_hCYP3A4 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity of HFC with fluorimetry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity of HFC produced from the regulation of catalytic activity reaction involving the key substrate, 7-benzyloxy-4-trifluoromethylcoumarin (BFC), are indicative of changes in enzyme function and kinetics related to the gene CYP3A4.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorimetry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-benzyloxy-4-trifluoromethylcoumarin (BFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 809, + "assayName": "ERF_CR_ADME_hCYP3A4", + "assayDesc": "ERF_CR_ADME_hCYP3A4 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See CYP3A4 inhibition (recombinant, BFC substrate).", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cyp", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 90, + "geneName": "cytochrome P450, family 3, subfamily A, polypeptide 4", + "description": null, + "geneSymbol": "CYP3A4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1576, + "officialSymbol": "CYP3A4", + "officialFullName": "cytochrome P450, family 3, subfamily A, polypeptide 4", + "uniprotAccessionNumber": "P08684" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2557, + "assayComponentEndpointName": "ERF_PL_ENZ_bPDE1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_bPDE1 was analyzed at the assay endpoint, ERF_PL_ENZ_bPDE1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene PDE1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphodiesterase intended target family, where the subfamily is cyclic nucleotide signaling.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "3-Isobutyl-1-methylxanthine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2510, + "assayComponentName": "ERF_PL_ENZ_bPDE1", + "assayComponentDesc": "ERF_PL_ENZ_bPDE1 is an assay component calculated from the ERF_PL_ENZ_bPDE1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, [3H]cAMP + cAMP, are indicative of changes in enzyme function and kinetics related to the gene PDE1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "[3H]cAMP + cAMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 711, + "assayName": "ERF_PL_ENZ_bPDE1", + "assayDesc": "ERF_PL_ENZ_bPDE1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.33 hour after chemical dosing in a 96-well plate. See PDE1 (Non-Selective) Bovine Phosphodiesterase Enzymatic Assay, Panlabs.", + "timepointHr": 0.33, + "organismId": 9913, + "organism": "bovine", + "tissue": "brain", + "cellFormat": "cell-free", + "cellFreeComponentSource": "bovine brain", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 368, + "geneName": "phosphodiesterase 10A", + "description": null, + "geneSymbol": "PDE10A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10846, + "officialSymbol": "PDE10A", + "officialFullName": "phosphodiesterase 10A", + "uniprotAccessionNumber": "Q9Y233" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2558, + "assayComponentEndpointName": "ERF_CR_ENZ_hABL1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hABL1 was analyzed at the assay endpoint, ERF_CR_ENZ_hABL1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene ABL1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2511, + "assayComponentName": "ERF_CR_ENZ_hABL1", + "assayComponentDesc": "ERF_CR_ENZ_hABL1 is an assay component calculated from the ERF_CR_ENZ_hABL1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-TK peptide, are indicative of changes in enzyme function and kinetics related to the gene ABL1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-TK peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 791, + "assayName": "ERF_CR_ENZ_hABL1", + "assayDesc": "ERF_CR_ENZ_hABL1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See Abl Human TK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 1, + "geneName": "ABL proto-oncogene 1, non-receptor tyrosine kinase", + "description": null, + "geneSymbol": "ABL1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 25, + "officialSymbol": "ABL1", + "officialFullName": "ABL proto-oncogene 1, non-receptor tyrosine kinase", + "uniprotAccessionNumber": "P00519" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2559, + "assayComponentEndpointName": "ERF_CR_ENZ_hAKT2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hAKT2 was analyzed at the assay endpoint, ERF_CR_ENZ_hAKT2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene AKT2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2512, + "assayComponentName": "ERF_CR_ENZ_hAKT2", + "assayComponentDesc": "ERF_CR_ENZ_hAKT2 is an assay component calculated from the ERF_CR_ENZ_hAKT2 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-RRRSLLE, are indicative of changes in enzyme function and kinetics related to the gene AKT2.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-RRRSLLE", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 781, + "assayName": "ERF_CR_ENZ_hAKT2", + "assayDesc": "ERF_CR_ENZ_hAKT2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See Akt2 (PKBbeta) Human AGC Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 23, + "geneName": "v-akt murine thymoma viral oncogene homolog 2", + "description": null, + "geneSymbol": "AKT2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 208, + "officialSymbol": "AKT2", + "officialFullName": "v-akt murine thymoma viral oncogene homolog 2", + "uniprotAccessionNumber": "P31751" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2560, + "assayComponentEndpointName": "ERF_CR_ENZ_hAKT3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hAKT3 was analyzed at the assay endpoint, ERF_CR_ENZ_hAKT3, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene AKT3. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2513, + "assayComponentName": "ERF_CR_ENZ_hAKT3", + "assayComponentDesc": "ERF_CR_ENZ_hAKT3 is an assay component calculated from the ERF_CR_ENZ_hAKT3 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-RRRSLLE, are indicative of changes in enzyme function and kinetics related to the gene AKT3.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-RRRSLLE", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 782, + "assayName": "ERF_CR_ENZ_hAKT3", + "assayDesc": "ERF_CR_ENZ_hAKT3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See Akt3 (PKBgamma) Human AGC Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 359, + "geneName": "v-akt murine thymoma viral oncogene homolog 3", + "description": null, + "geneSymbol": "AKT3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10000, + "officialSymbol": "AKT3", + "officialFullName": "v-akt murine thymoma viral oncogene homolog 3", + "uniprotAccessionNumber": "Q9Y243" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2561, + "assayComponentEndpointName": "ERF_CR_ENZ_hAURKA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hAURKA was analyzed at the assay endpoint, ERF_CR_ENZ_hAURKA, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene AURKA. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2514, + "assayComponentName": "ERF_CR_ENZ_hAURKA", + "assayComponentDesc": "ERF_CR_ENZ_hAURKA is an assay component calculated from the ERF_CR_ENZ_hAURKA assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-RRRSLLE , are indicative of changes in enzyme function and kinetics related to the gene AURKA.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-RRRSLLE ", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 774, + "assayName": "ERF_CR_ENZ_hAURKA", + "assayDesc": "ERF_CR_ENZ_hAURKA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See Aurora-A Human Other Protein Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant Sf21 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 306, + "geneName": "aurora kinase A", + "description": null, + "geneSymbol": "AURKA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6790, + "officialSymbol": "AURKA", + "officialFullName": "aurora kinase A", + "uniprotAccessionNumber": "O14965" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2562, + "assayComponentEndpointName": "ERF_PL_ENZ_hBTK", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_hBTK was analyzed at the assay endpoint, ERF_PL_ENZ_hBTK, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene BTK. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is tyrosine kinase (tk).", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": " tyrosine kinase (tk)", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2515, + "assayComponentName": "ERF_PL_ENZ_hBTK", + "assayComponentDesc": "ERF_PL_ENZ_hBTK is an assay component calculated from the ERF_PL_ENZ_hBTK assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, Poly(Glu:Tyr), are indicative of changes in enzyme function and kinetics related to the gene BTK.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Poly(Glu:Tyr)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 726, + "assayName": "ERF_PL_ENZ_hBTK", + "assayDesc": "ERF_PL_ENZ_hBTK is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See BTK Human TK Kinase Enzymatic Radiometric Assay [10 uM ATP], Panlabs.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect Sf21 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 36, + "geneName": "Bruton agammaglobulinemia tyrosine kinase", + "description": null, + "geneSymbol": "BTK", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 695, + "officialSymbol": "BTK", + "officialFullName": "Bruton agammaglobulinemia tyrosine kinase", + "uniprotAccessionNumber": "Q06187" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2563, + "assayComponentEndpointName": "ERF_CR_ENZ_hCDK2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hCDK2 was analyzed at the assay endpoint, ERF_CR_ENZ_hCDK2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CDK2. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2516, + "assayComponentName": "ERF_CR_ENZ_hCDK2", + "assayComponentDesc": "ERF_CR_ENZ_hCDK2 is an assay component calculated from the ERF_CR_ENZ_hCDK2 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-CFFKNIVTPRTPPPSQGK-amide, are indicative of changes in enzyme function and kinetics related to the gene CDK2.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-CFFKNIVTPRTPPPSQGK-amide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 780, + "assayName": "ERF_CR_ENZ_hCDK2", + "assayDesc": "ERF_CR_ENZ_hCDK2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See CDK2 /CyclinA Human CMGC Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 55, + "geneName": "cyclin-dependent kinase 2", + "description": null, + "geneSymbol": "CDK2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1017, + "officialSymbol": "CDK2", + "officialFullName": "cyclin-dependent kinase 2", + "uniprotAccessionNumber": "P24941" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2564, + "assayComponentEndpointName": "ERF_PL_ENZ_hCHK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_hCHK1 was analyzed at the assay endpoint, ERF_PL_ENZ_hCHK1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CHEK1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2517, + "assayComponentName": "ERF_PL_ENZ_hCHK1", + "assayComponentDesc": "ERF_PL_ENZ_hCHK1 is an assay component calculated from the ERF_PL_ENZ_hCHK1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, CHKtide, are indicative of changes in enzyme function and kinetics related to the gene CHEK1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CHKtide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 719, + "assayName": "ERF_PL_ENZ_hCHK1", + "assayDesc": "ERF_PL_ENZ_hCHK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See CHK1 Human CAMK Kinase Enzymatic Radiometric Assay [10 uM ATP], Panlabs.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect Sf21 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 60, + "geneName": "checkpoint kinase 1", + "description": null, + "geneSymbol": "CHEK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1111, + "officialSymbol": "CHEK1", + "officialFullName": "checkpoint kinase 1", + "uniprotAccessionNumber": "O14757" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2566, + "assayComponentEndpointName": "ERF_CR_ENZ_hCSF1R", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hCSF1R was analyzed at the assay endpoint, ERF_CR_ENZ_hCSF1R, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CSF1R. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2519, + "assayComponentName": "ERF_CR_ENZ_hCSF1R", + "assayComponentDesc": "ERF_CR_ENZ_hCSF1R is an assay component calculated from the ERF_CR_ENZ_hCSF1R assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-TK peptide, are indicative of changes in receptor function and kinetics related to the gene CSF1R.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-TK peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 793, + "assayName": "ERF_CR_ENZ_hCSF1R", + "assayDesc": "ERF_CR_ENZ_hCSF1R is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See Fms (CSFR) Human RTK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 73, + "geneName": "colony stimulating factor 1 receptor", + "description": null, + "geneSymbol": "CSF1R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1436, + "officialSymbol": "CSF1R", + "officialFullName": "colony stimulating factor 1 receptor", + "uniprotAccessionNumber": "P07333" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2567, + "assayComponentEndpointName": "ERF_PL_ENZ_hCSNK1A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_hCSNK1A1 was analyzed at the assay endpoint, ERF_PL_ENZ_hCSNK1A1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CSNK1A1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "IC 261", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2520, + "assayComponentName": "ERF_PL_ENZ_hCSNK1A1", + "assayComponentDesc": "ERF_PL_ENZ_hCSNK1A1 is an assay component calculated from the ERF_PL_ENZ_hCSNK1A1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, CK1 substrate peptide, are indicative of changes in enzyme function and kinetics related to the gene CSNK1A1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CK1 substrate peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 720, + "assayName": "ERF_PL_ENZ_hCSNK1A1", + "assayDesc": "ERF_PL_ENZ_hCSNK1A1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See CK1alpha Human CK1 Kinase Enzymatic Radiometric Assay [10 uM ATP], Panlabs.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 74, + "geneName": "casein kinase 1, alpha 1", + "description": null, + "geneSymbol": "CSNK1A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1452, + "officialSymbol": "CSNK1A1", + "officialFullName": "casein kinase 1, alpha 1", + "uniprotAccessionNumber": "P48729" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2568, + "assayComponentEndpointName": "ERF_PL_ENZ_hCSNK1D", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_hCSNK1D was analyzed at the assay endpoint, ERF_PL_ENZ_hCSNK1D, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CSNK1D. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "IC 261", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2521, + "assayComponentName": "ERF_PL_ENZ_hCSNK1D", + "assayComponentDesc": "ERF_PL_ENZ_hCSNK1D is an assay component calculated from the ERF_PL_ENZ_hCSNK1D assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, CK1tide, are indicative of changes in enzyme function and kinetics related to the gene CSNK1D.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CK1tide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 722, + "assayName": "ERF_PL_ENZ_hCSNK1D", + "assayDesc": "ERF_PL_ENZ_hCSNK1D is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See CK1delta Human CK1 Kinase Enzymatic Radiometric Assay [10 uM ATP], Panlabs.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 75, + "geneName": "casein kinase 1, delta", + "description": null, + "geneSymbol": "CSNK1D", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1453, + "officialSymbol": "CSNK1D", + "officialFullName": "casein kinase 1, delta", + "uniprotAccessionNumber": "P48730" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1843, + "assayComponentEndpointName": "TOX21_H2AX_HTRF_CHO_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_H2AX_HTRF_CHO_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_H2AX_HTRF_CHO_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene H2AFX. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is histone.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Etoposide", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "histone H2A", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1141, + "assayComponentName": "TOX21_H2AX_HTRF_CHO_Agonist_ratio", + "assayComponentDesc": "TOX21_H2AX_HTRF_CHO_Agonist_ratio is an assay readout measuring protein phosphorylation and designed using homogenous time resolved fluorescence between two labled antibodies. The signal is derived from the the ratio of acceptor (d2)-conjugated antibody emission (ch2) to donor (Europium-cryptate)-conjugated antibody emission (ch1) used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_H2AX_HTRF_CHO_Agonist_ratio was designed to target protein phosphorylation, specifically mapping to H2AFX gene(s) using a positive control of Etoposide", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Homogeneous Time Resolved Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 451, + "assayName": "TOX21_H2AX_HTRF_CHO_Agonist", + "assayDesc": "TOX21_H2AX_HTRF_CHO_Agonist is a cell-based, single-readout assay that uses CHO-K1, a chinese hamster ovary cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 10029, + "organism": "chinese hamster", + "tissue": "ovary", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "CHO-K1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 149, + "geneName": "H2A histone family, member X", + "description": null, + "geneSymbol": "H2AFX", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3014, + "officialSymbol": "H2AFX", + "officialFullName": "H2A histone family, member X", + "uniprotAccessionNumber": "P16104" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.9b00053", + "url": "https://pubmed.ncbi.nlm.nih.gov/31243984/", + "pmid": 31243984, + "title": "Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays", + "author": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL", + "citation": "Hsieh JH, Smith-Roe SL, Huang R, Sedykh A, Shockley KR, Auerbach SS, Merrick BA, Xia M, Tice RR, Witt KL. Identifying Compounds with Genotoxicity Potential Using Tox21 High-Throughput Screening Assays. Chem Res Toxicol. 2019 Jul 15;32(7):1384-1401. doi: 10.1021/acs.chemrestox.9b00053. Epub 2019 Jun 18. PMID: 31243984; PMCID: PMC6740247.", + "otherId": "0", + "citationId": 274, + "otherSource": "" + } + }, + { + "aeid": 1844, + "assayComponentEndpointName": "TOX21_AP1_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AP1_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AP1_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene JUN|FOS|JUN. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "EGF", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1142, + "assayComponentName": "TOX21_AP1_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_AP1_BLA_Agonist_ch1 is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_AP1_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target transcription factor activity, specifically mapping to JUN gene(s) using a positive control of EGF", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 452, + "assayName": "TOX21_AP1_BLA_Agonist", + "assayDesc": "TOX21_AP1_BLA_Agonist is a cell-based, single-readout assay that uses ME-180, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ME-180", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1845, + "assayComponentEndpointName": "TOX21_AP1_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AP1_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AP1_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene JUN|FOS|JUN. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "EGF", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1143, + "assayComponentName": "TOX21_AP1_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_AP1_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_AP1_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target transcription factor activity, specifically mapping to JUN gene(s) using a positive control of EGF", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 452, + "assayName": "TOX21_AP1_BLA_Agonist", + "assayDesc": "TOX21_AP1_BLA_Agonist is a cell-based, single-readout assay that uses ME-180, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ME-180", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": null + }, + { + "aeid": 1846, + "assayComponentEndpointName": "TOX21_AP1_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AP1_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AP1_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene JUN|FOS|JUN. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic leucine zipper.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "EGF", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1144, + "assayComponentName": "TOX21_AP1_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_AP1_BLA_Agonist_ratio is an assay readout measuring reporter gene via transcription factor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_AP1_BLA_Agonist_ratio was designed to target transcription factor activity, specifically mapping to JUN gene(s) using a positive control of EGF", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 452, + "assayName": "TOX21_AP1_BLA_Agonist", + "assayDesc": "TOX21_AP1_BLA_Agonist is a cell-based, single-readout assay that uses ME-180, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ME-180", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 183, + "geneName": "jun proto-oncogene", + "description": null, + "geneSymbol": "JUN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3725, + "officialSymbol": "JUN", + "officialFullName": "jun proto-oncogene", + "uniprotAccessionNumber": "P05412" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2569, + "assayComponentEndpointName": "ERF_PL_ENZ_hCSNK2A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_hCSNK2A1 was analyzed at the assay endpoint, ERF_PL_ENZ_hCSNK2A1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CSNK2A1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "hypericin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2522, + "assayComponentName": "ERF_PL_ENZ_hCSNK2A1", + "assayComponentDesc": "ERF_PL_ENZ_hCSNK2A1 is an assay component calculated from the ERF_PL_ENZ_hCSNK2A1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by scintillation counting with radiometry technology.", + "assayComponentTargetDesc": "Changes in scintillation counting produced from the regulation of catalytic activity reaction involving the key substrate, CK2 substrate peptide, are indicative of changes in enzyme function and kinetics related to the gene CSNK2A1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CK2 substrate peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 723, + "assayName": "ERF_PL_ENZ_hCSNK2A1", + "assayDesc": "ERF_PL_ENZ_hCSNK2A1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See CK2 (alpha1/alpha2/beta) Human Other Protein Kinase Enzymatic Radiometric Assay [10 uM ATP], Panlabs.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant Sf21 insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 76, + "geneName": "casein kinase 2, alpha 1 polypeptide", + "description": null, + "geneSymbol": "CSNK2A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1457, + "officialSymbol": "CSNK2A1", + "officialFullName": "casein kinase 2, alpha 1 polypeptide", + "uniprotAccessionNumber": "Q8NEV1" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2570, + "assayComponentEndpointName": "ERF_PL_ENZ_hCYP19A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_PL_ENZ_hCYP19A1 was analyzed at the assay endpoint, ERF_PL_ENZ_hCYP19A1, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CYP19A1. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is steroidogenesis-related.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "testosterone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp ", + "intendedTargetFamilySub": "steroidogenesis-related", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2523, + "assayComponentName": "ERF_PL_ENZ_hCYP19A1", + "assayComponentDesc": "ERF_PL_ENZ_hCYP19A1 is an assay component calculated from the ERF_PL_ENZ_hCYP19A1 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with spectrophotometry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, dibenzylfluorescein, are indicative of changes in enzyme function and kinetics related to the gene CYP19A1.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Colorimetric", + "detectionTechnologyTypeSub": "Absorbance ", + "detectionTechnology": "spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "dibenzylfluorescein", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 698, + "assayName": "ERF_PL_ENZ_hCYP19A1", + "assayDesc": "ERF_PL_ENZ_hCYP19A1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.75 hour after chemical dosing in a 96-well plate. See CYP19A1 Human CYP450 Enzymatic Assay, Panlabs.", + "timepointHr": 0.75, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect BTI-TN-5B1-4 cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 94, + "geneName": "cytochrome P450, family 19, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP19A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1588, + "officialSymbol": "CYP19A1", + "officialFullName": "cytochrome P450, family 19, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "P11511" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2571, + "assayComponentEndpointName": "ERF_CR_ENZ_hDUSP3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hDUSP3 was analyzed at the assay endpoint, ERF_CR_ENZ_hDUSP3, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene DUSP3. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is dual-specific kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "sodium orthovanadate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "dual-specific kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2524, + "assayComponentName": "ERF_CR_ENZ_hDUSP3", + "assayComponentDesc": "ERF_CR_ENZ_hDUSP3 is an assay component calculated from the ERF_CR_ENZ_hDUSP3 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with spectrophotometry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, 6,8-difluoro-4-methylumbelliferyl, are indicative of changes in enzyme function and kinetics related to the gene DUSP3.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Colorimetric", + "detectionTechnologyTypeSub": "Absorbance ", + "detectionTechnology": "spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "6,8-difluoro-4-methylumbelliferyl", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 703, + "assayName": "ERF_CR_ENZ_hDUSP3", + "assayDesc": "ERF_PL_ENZ_hDUSP3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See VHR Human Phosphatase Enzymatic Assay, PhosphataseProfiler.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human full length recombinant", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 102, + "geneName": "dual specificity phosphatase 3", + "description": null, + "geneSymbol": "DUSP3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1845, + "officialSymbol": "DUSP3", + "officialFullName": "dual specificity phosphatase 3", + "uniprotAccessionNumber": "P51452" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2572, + "assayComponentEndpointName": "ERF_CR_ENZ_hDYRK1A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hDYRK1A was analyzed at the assay endpoint, ERF_CR_ENZ_hDYRK1A, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene DYRK1A. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2525, + "assayComponentName": "ERF_CR_ENZ_hDYRK1A", + "assayComponentDesc": "ERF_CR_ENZ_hDYRK1A is an assay component calculated from the ERF_CR_ENZ_hDYRK1A assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-CFFKNIVTPRTPPPSQGK-amide, are indicative of changes in enzyme function and kinetics related to the gene DYRK1A.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-CFFKNIVTPRTPPPSQGK-amide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 766, + "assayName": "ERF_CR_ENZ_hDYRK1A", + "assayDesc": "ERF_CR_ENZ_hDYRK1A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See DYRK1A Human CMGC Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 103, + "geneName": "dual-specificity tyrosine-(Y)-phosphorylation regulated kinase 1A", + "description": null, + "geneSymbol": "DYRK1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1859, + "officialSymbol": "DYRK1A", + "officialFullName": "dual-specificity tyrosine-(Y)-phosphorylation regulated kinase 1A", + "uniprotAccessionNumber": "Q13627" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1847, + "assayComponentEndpointName": "TOX21_AP1_BLA_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_AP1_BLA_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1145, + "assayComponentName": "TOX21_AP1_BLA_Agonist_viability", + "assayComponentDesc": "TOX21_AP1_BLA_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 452, + "assayName": "TOX21_AP1_BLA_Agonist", + "assayDesc": "TOX21_AP1_BLA_Agonist is a cell-based, single-readout assay that uses ME-180, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "ME-180", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": null, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 1848, + "assayComponentEndpointName": "CCTE_Simmons_QuantiLum_inhib_2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CCTE_Simmons_QuantiLum_inhib_2 was analyzed at the endpoint, CCTE_Simmons_QuantiLum_inhib_2, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, measures of enzyme activity for loss-of-signal activity can be used to understand inhibition of firefly luciferase. This is an assay endpoint to indicate nonspecific protein inhibition for comparison to aeid 1508 for thyroperoxidase inhibition. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is monooxygenase.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "b-naphthoquinone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "monooxygenase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1146, + "assayComponentName": "CCTE_Simmons_QuantiLum_inhib_2", + "assayComponentDesc": "CCTE_Simmons_QuantiLum_inhib_2 is the assay component measured from the CCTE_Simmons_QuantiLum_inhib_2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with bioluminescence signals by Luciferase-coupled Quantilum levels technology. This is a secondary assay to CCTE_Simmons_AUR_TPO to to evaluate nonspecific enzyme inhibition.", + "assayComponentTargetDesc": "CCTE_Simmons_QuantiLum_inhib_2 was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [Luciferase detection reagent] and is used to understand nonspecific enzyme inhibition.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "Luciferase-coupled Quantilum levels", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Luciferase detection reagent", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 453, + "assayName": "CCTE_Simmons_QuantiLum_inhib_2", + "assayDesc": "CCTE_Simmons_QuantiLum_inhib_2 is a biochemical, single-readout assay that uses purified luciferase enzyme in a cell-free assay.Measurements were taken 0.5 hour after chemical dosing in a 384-well plate.", + "timepointHr": 0.5, + "organismId": 0, + "organism": "E.coli", + "tissue": "purified enzyme", + "cellFormat": "cell-free", + "cellFreeComponentSource": "overexpression in E. coli", + "cellShortName": "", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.2, + "asid": 17, + "assaySourceName": "CCTE", + "assaySourceLongName": "CCTE Labs", + "assaySourceDesc": "The EPA Center for Computational Toxicology and Exposure labs focus on developing and implementing in vitro methods to identify potential environmental toxicants. Principal investigators include Steve Simmons, Joshua Harrill, and Chad Deisenroth.", + "gene": { + "geneId": 497, + "geneName": "luciferase [Cloning vector pGL3-Basic, complete sequence]", + "description": null, + "geneSymbol": null, + "organismId": 12, + "trackStatus": "live", + "entrezGeneId": null, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "U47295" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1021/tx400310w", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24383450", + "pmid": 24383450, + "title": "Development of a thyroperoxidase inhibition assay for high-throughput screening", + "author": "Paul KB, Hedge JM, Rotroff DM, Hornung MW, Crofton KM, Simmons SO", + "citation": "Paul KB, Hedge JM, Rotroff DM, Hornung MW, Crofton KM, Simmons SO. Development of a thyroperoxidase inhibition assay for high-throughput screening. Chem Res Toxicol. 2014 Mar 17;27(3):387-99. doi: 10.1021/tx400310w. Epub 2014 Jan 14. PubMed PMID: 24383450.", + "otherId": "0", + "citationId": 218, + "otherSource": "" + } + }, + { + "aeid": 1850, + "assayComponentEndpointName": "ACEA_AR_agonist_AUC_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ACEA_AR_AUC_viability was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of growth reporter, loss-of-signal activity can be used to understand changes in the viability. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "MG 132", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1802, + "assayComponentName": "ACEA_AR_agonist_AUC_viability", + "assayComponentDesc": "ACEA_AR_80hr is one of two assay component(s) measured or calculated from the ACEA_AR assay. It is designed to make measurements of real-time cell-growth kinetics, a form of growth reporter, as detected with electrical impedance signals by Real-Time Cell Electrode Sensor (RT-CES) technology.", + "assayComponentTargetDesc": "Electrical impedance is used to quantify changes to the growth of the cells where increase impedance is positively correlated with increased cell growth", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "real-time cell-growth kinetics", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Label Free Technology", + "detectionTechnologyTypeSub": "Electrical Sensor: Impedance", + "detectionTechnology": "RT-CES", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "cellular", + "aid": 533, + "assayName": "ACEA_AR_agonist", + "assayDesc": "ACEA_AR_agonist is a cell-based, single-readout assay that uses 22Rv1, a human prostate cancer cell line, with measurements taken at 80 hours after chemical dosing in a 96-well or 384-well plate.", + "timepointHr": 80.0, + "organismId": 9606, + "organism": "human", + "tissue": "prostate", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "22Rv1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 1, + "assaySourceName": "ACEA", + "assaySourceLongName": "ACEA Biosciences", + "assaySourceDesc": "ACEA Biosciences, Inc. (ACEA) is a privately owned biotechnology company that developed a real-time, label-free, cell growth assay system called xCELLigence based on a microelectronic impedance readout .", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 1852, + "assayComponentEndpointName": "ACEA_ER_AUC_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ACEA_ER_AUC_viability was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of growth reporter, loss-of-signal activity can be used to understand changes in the viability. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "MG 132", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1804, + "assayComponentName": "ACEA_ER_AUC_viability", + "assayComponentDesc": "ACEA_ER_AUC_viability is one of two assay component(s) measured or calculated from the ACEA_ER assay. It is designed to make measurements of real-time cell-growth kinetics, a form of growth reporter, as detected with electrical impedance signals by Real-Time Cell Electrode Sensor (RT-CES) technology.", + "assayComponentTargetDesc": "Electrical impedance is used to quantify changes to the growth of the cells where increase impedance is positively correlated with increased cell growth", + "parameterReadoutType": "single", + "assayDesignType": "growth reporter", + "assayDesignTypeSub": "real-time cell-growth kinetics", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Label Free Technology", + "detectionTechnologyTypeSub": "Electrical Sensor: Impedance", + "detectionTechnology": "RT-CES", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "cellular", + "aid": 1, + "assayName": "ACEA_ER", + "assayDesc": "ACEA_ER is a cell-based, single-readout assay that uses T47D, a human breast cell line, with measurements taken at 80 hours after chemical dosing in a 96-well or 384-well plate.", + "timepointHr": 80.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "T47D", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 1, + "assaySourceName": "ACEA", + "assaySourceLongName": "ACEA Biosciences", + "assaySourceDesc": "ACEA Biosciences, Inc. (ACEA) is a privately owned biotechnology company that developed a real-time, label-free, cell growth assay system called xCELLigence based on a microelectronic impedance readout .", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16481145", + "pmid": 16481145, + "title": "Microelectronic cell sensor assay for detection of cytotoxicity and prediction of acute toxicity", + "author": "Xing JZ, Zhu L, Gabos S, Xie L", + "citation": "Xing JZ, Zhu L, Gabos S, Xie L. Microelectronic cell sensor assay for detection of cytotoxicity and prediction of acute toxicity. Toxicol In Vitro. 2006 Sep;20(6):995-1004. Epub 2006 Feb 14. PubMed PMID: 16481145.", + "otherId": "0", + "citationId": 209, + "otherSource": "" + } + }, + { + "aeid": 1855, + "assayComponentEndpointName": "ACEA_AR_agonist_80hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ACEA_AR_agonist_80hr was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of growth reporter, measures of the cells for gain-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the geneAR \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "signaling", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "testosterone", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1829, + "assayComponentName": "ACEA_AR_agonist_80hr", + "assayComponentDesc": "ACEA_AR_agonist_80hr is one of two assay component(s) measured or calculated from the ACEA_AR assay. It is designed to make measurements of real-time cell-growth kinetics, a form of growth reporter, as detected with electrical impedance signals by Real-Time Cell Electrode Sensor (RT-CES) technology.", + "assayComponentTargetDesc": "Electrical impedance is used to quantify changes to the growth of the cells where increase impedance is positively correlated with increased cell growth", + "parameterReadoutType": "single", + "assayDesignType": "growth reporter", + "assayDesignTypeSub": "real-time cell-growth kinetics", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Label Free Technology", + "detectionTechnologyTypeSub": "Electrical Sensor: Impedance", + "detectionTechnology": "RT-CES", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "cellular", + "aid": 533, + "assayName": "ACEA_AR_agonist", + "assayDesc": "ACEA_AR_agonist is a cell-based, single-readout assay that uses 22Rv1, a human prostate cancer cell line, with measurements taken at 80 hours after chemical dosing in a 96-well or 384-well plate.", + "timepointHr": 80.0, + "organismId": 9606, + "organism": "human", + "tissue": "prostate", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "22Rv1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 1, + "assaySourceName": "ACEA", + "assaySourceLongName": "ACEA Biosciences", + "assaySourceDesc": "ACEA Biosciences, Inc. (ACEA) is a privately owned biotechnology company that developed a real-time, label-free, cell growth assay system called xCELLigence based on a microelectronic impedance readout .", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1856, + "assayComponentEndpointName": "ACEA_AR_antagonist_80hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ACEA_AR_antagonist_80hr was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of growth reporter, measures of the cells for loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1830, + "assayComponentName": "ACEA_AR_antagonist_80hr", + "assayComponentDesc": "ACEA_AR_antagonist_80hr is one of two assay component(s) measured or calculated from the ACEA_AR assay. It is designed to make measurements of real-time cell-growth kinetics, a form of growth reporter, as detected with electrical impedance signals by Real-Time Cell Electrode Sensor (RT-CES) technology.", + "assayComponentTargetDesc": "Electrical impedance is used to quantify changes to the growth of the cells where increase impedance is positively correlated with increased cell growth", + "parameterReadoutType": "single", + "assayDesignType": "growth reporter", + "assayDesignTypeSub": "real-time cell-growth kinetics", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Label Free Technology", + "detectionTechnologyTypeSub": "Electrical Sensor: Impedance", + "detectionTechnology": "RT-CES", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "cellular", + "aid": 534, + "assayName": "ACEA_AR_antagonist", + "assayDesc": "ACEA_AR_antagonist is a cell-based, single-readout assay that uses 22Rv1, a human prostate cancer cell line, with measurements taken at 80 hours after chemical dosing in a 96-well or 384-well plate.", + "timepointHr": 80.0, + "organismId": 9606, + "organism": "human", + "tissue": "prostate", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "22Rv1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 1, + "assaySourceName": "ACEA", + "assaySourceLongName": "ACEA Biosciences", + "assaySourceDesc": "ACEA Biosciences, Inc. (ACEA) is a privately owned biotechnology company that developed a real-time, label-free, cell growth assay system called xCELLigence based on a microelectronic impedance readout .", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 1857, + "assayComponentEndpointName": "ACEA_AR_antagonist_AUC_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ACEA_AR_antagonist_AUC_viability was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of growth reporter, loss-of-signal activity can be used to understand changes in the viability. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "MG 132", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 1831, + "assayComponentName": "ACEA_AR_antagonist_AUC_viability", + "assayComponentDesc": "ACEA_AR_80hr is one of two assay component(s) measured or calculated from the ACEA_ER assay. It is designed to make measurements of real-time cell-growth kinetics, a form of growth reporter, as detected with electrical impedance signals by Real-Time Cell Electrode Sensor (RT-CES) technology.", + "assayComponentTargetDesc": "Electrical impedance is used to quantify changes to the growth of the cells where increase impedance is positively correlated with increased cell growth", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "real-time cell-growth kinetics", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Label Free Technology", + "detectionTechnologyTypeSub": "Electrical Sensor: Impedance", + "detectionTechnology": "RT-CES", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "cellular", + "aid": 534, + "assayName": "ACEA_AR_antagonist", + "assayDesc": "ACEA_AR_antagonist is a cell-based, single-readout assay that uses 22Rv1, a human prostate cancer cell line, with measurements taken at 80 hours after chemical dosing in a 96-well or 384-well plate.", + "timepointHr": 80.0, + "organismId": 9606, + "organism": "human", + "tissue": "prostate", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "22Rv1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 1, + "assaySourceName": "ACEA", + "assaySourceLongName": "ACEA Biosciences", + "assaySourceDesc": "ACEA Biosciences, Inc. (ACEA) is a privately owned biotechnology company that developed a real-time, label-free, cell growth assay system called xCELLigence based on a microelectronic impedance readout .", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 1858, + "assayComponentEndpointName": "STM_H9_NormalizedViability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component STM_H9_Viability was analyzed at the assay endpoint STM_H9_Viability_Norm in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, loss-of-signal activity can be used to understand viability.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1114, + "assayComponentName": "STM_H9_NormalizedViability", + "assayComponentDesc": "STM_H9_NormalizedViability is a component calculated in the STM_H9_viability assay. It measures cell viability using background corrected relative fluorescence units (RFU) value from the CellTiterFluor Assay normalized to the value of the 0.1% DMSO neutral control treatment (by 96-well plate)", + "assayComponentTargetDesc": "Changes in fluorescence are indicative of changes in cell viability. ", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell viability", + "biologicalProcessTarget": "cell viability", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "fluorescent signal proportional to the number of living cells", + "detectionTechnology": "CellTiter-FluorTM", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "fluorescent signal", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "living cells", + "aid": 437, + "assayName": "STM_H9_viability", + "assayDesc": "STM_H9_viability utilizes undifferentiated H9 cells to measure cell viability.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-based", + "cellFreeComponentSource": "H9 embryonic stem cell line", + "cellShortName": "hESC", + "cellGrowthMode": "monolayer", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "metabolomic", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 14, + "assaySourceName": "STM", + "assaySourceLongName": "Stemina Biomarker Discovery", + "assaySourceDesc": "Stemina Biomarker Discovery is a Contract Research Organization (CRO) that provides stem cell-based developmental toxicity screening for chemical compounds. ", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfaa014", + "url": "https://pubmed.ncbi.nlm.nih.gov/32073639/", + "pmid": 32073639, + "title": "Profiling the ToxCast Library With a Pluripotent Human (H9) Stem Cell Line-Based Biomarker Assay for Developmental Toxicity", + "author": "Zurlinden TJ, Saili KS, Rush N, Kothiya P, Judson RS, Houck KA, Hunter ES, Baker NC, Palmer JA, Thomas RS, Knudsen TB", + "citation": "Zurlinden TJ, Saili KS, Rush N, Kothiya P, Judson RS, Houck KA, Hunter ES, Baker NC, Palmer JA, Thomas RS, Knudsen TB. Profiling the ToxCast Library With a Pluripotent Human (H9) Stem Cell Line-Based Biomarker Assay for Developmental Toxicity. Toxicol Sci. 2020 Apr 1;174(2):189-209. doi: 10.1093/toxsci/kfaa014. PMID: 32073639.", + "otherId": "0", + "citationId": 248, + "otherSource": "" + } + }, + { + "aeid": 89, + "assayComponentEndpointName": "ATG_M_32_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_M_32_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_M_32_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \n\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 58, + "assayComponentName": "ATG_M_32_CIS", + "assayComponentDesc": "ATG_M_32_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene M_32, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M32 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 1913, + "assayComponentEndpointName": "ATG_chAR_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_chAR_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1856, + "assayComponentName": "ATG_chAR_XSP1", + "assayComponentDesc": "ATG_chAR_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element AR, which is responsive to the chicken androgen receptor. [GeneSymbol:ar | GeneID:422165| Uniprot_SwissProt_Accession:Q2ACE0].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-chAR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1474, + "geneName": "androgen receptor", + "description": "androgen receptor (chicken)", + "geneSymbol": "AR", + "organismId": 45, + "trackStatus": null, + "entrezGeneId": 422165, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "Q2ACE0" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1915, + "assayComponentEndpointName": "ATG_frAR_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frAR_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1857, + "assayComponentName": "ATG_frAR_XSP1", + "assayComponentDesc": "ATG_frAR_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element AR, which is responsive to the frog androgen receptor. [GeneSymbol:ar.L | GeneID:399456| Uniprot_SwissProt_Accession:P70048].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frAR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1479, + "geneName": "androgen receptor L homeolog", + "description": "androgen receptor L homeolog [Xenopus laevis (African clawed frog)]", + "geneSymbol": "ar.L", + "organismId": 46, + "trackStatus": null, + "entrezGeneId": 399456, + "officialSymbol": "ar.L", + "officialFullName": "androgen receptor (dihydrotestosterone receptor; testicular feminization; spinal and bulbar muscular atrophy; Kennedy disease) L homeolog", + "uniprotAccessionNumber": "P70048" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1917, + "assayComponentEndpointName": "ATG_hAR_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hAR_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1858, + "assayComponentName": "ATG_hAR_XSP1", + "assayComponentDesc": "ATG_hAR_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element AR, which is responsive to the human androgen receptor. [GeneSymbol:AR | GeneID:367 | Uniprot_SwissProt_Accession:P10275].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-AR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1919, + "assayComponentEndpointName": "ATG_trAR_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_trAR_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1859, + "assayComponentName": "ATG_trAR_XSP1", + "assayComponentDesc": "ATG_trAR_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element AR, which is responsive to the turtle androgen receptor. [GeneSymbol:AR | GeneID:101947425 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-trAR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1464, + "geneName": "androgen receptor", + "description": "PREDICTED: Chrysemys picta bellii androgen receptor (AR), mRNA", + "geneSymbol": "AR", + "organismId": 42, + "trackStatus": null, + "entrezGeneId": 101947425, + "officialSymbol": "NA", + "officialFullName": "NA", + "uniprotAccessionNumber": "NA" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 2573, + "assayComponentEndpointName": "ERF_CR_ENZ_hEGFR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ENZ_hEGFR was analyzed at the assay endpoint, ERF_CR_ENZ_hEGFR, in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene EGFR. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "hydrochloride", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2526, + "assayComponentName": "ERF_CR_ENZ_hEGFR", + "assayComponentDesc": "ERF_CR_ENZ_hEGFR is an assay component calculated from the ERF_CR_ENZ_hEGFR assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity with LANCE technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity produced from the regulation of catalytic activity reaction involving the key substrate, ATP + Ulight-CAGAGAIETDKEYYTVKD, are indicative of changes in receptor function and kinetics related to the gene EGFR.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "LANCE", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "ATP + Ulight-CAGAGAIETDKEYYTVKD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 768, + "assayName": "ERF_CR_ENZ_hEGFR", + "assayDesc": "ERF_CR_ENZ_hEGFR is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate. See EGFR Human RTK Kinase Enzymatic LANCE Assay [Km ATP], Cerep.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 108, + "geneName": "epidermal growth factor receptor", + "description": null, + "geneSymbol": "EGFR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1956, + "officialSymbol": "EGFR", + "officialFullName": "epidermal growth factor receptor", + "uniprotAccessionNumber": "P00533" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 628, + "assayComponentEndpointName": "NVS_GPCR_hAdra2A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hAdra2A was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hAdra2A, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene ADRA2A. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Oxymetazoline HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 365, + "assayComponentName": "NVS_GPCR_hAdra2A", + "assayComponentDesc": "NVS_GPCR_hAdra2A is one of one assay component(s) measured or calculated from the NVS_GPCR_hAdra2A assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-MK-912] are indicative of a change in receptor function and kinetics for the human adrenoceptor alpha 2A [GeneSymbol:ADRA2A | GeneID:150 | Uniprot_SwissProt_Accession:P08913].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-MK-912", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 179, + "assayName": "NVS_GPCR_hAdra2A", + "assayDesc": "NVS_GPCR_hAdra2A is a biochemical, single-readout assay that uses extracted gene-proteins from HT29 in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "HT29", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 13, + "geneName": "adrenoceptor alpha 2A", + "description": null, + "geneSymbol": "ADRA2A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 150, + "officialSymbol": "ADRA2A", + "officialFullName": "adrenoceptor alpha 2A", + "uniprotAccessionNumber": "P08913" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2564617", + "pmid": 2564617, + "title": "[3H]L-657,743 (MK-912): a new, high affinity, selective radioligand for brain alpha 2-adrenoceptors", + "author": "Pettibone DJ, Flagg SD, Totaro JA, Clineschmidt BV, Huff JR, Young SD, Chen R", + "citation": "Pettibone DJ, Flagg SD, Totaro JA, Clineschmidt BV, Huff JR, Young SD, Chen R. [3H]L-657,743 (MK-912): a new, high affinity, selective radioligand for brain alpha 2-adrenoceptors. Life Sci. 1989;44(7):459-67. PubMed PMID: 2564617.", + "otherId": "0", + "citationId": 60, + "otherSource": "" + } + }, + { + "aeid": 629, + "assayComponentEndpointName": "NVS_GPCR_hAdra2C", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hAdra2C was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hAdra2C, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene ADRA2C. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Oxymetazoline HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 366, + "assayComponentName": "NVS_GPCR_hAdra2C", + "assayComponentDesc": "NVS_GPCR_hAdra2C is one of one assay component(s) measured or calculated from the NVS_GPCR_hAdra2C assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-MK-912] are indicative of a change in receptor function and kinetics for the human adrenoceptor alpha 2C [GeneSymbol:ADRA2C | GeneID:152 | Uniprot_SwissProt_Accession:P18825].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-MK-912", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 180, + "assayName": "NVS_GPCR_hAdra2C", + "assayDesc": "NVS_GPCR_hAdra2C is a biochemical, single-readout assay that uses extracted gene-proteins from SF9 in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "SF9", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 14, + "geneName": "adrenoceptor alpha 2C", + "description": null, + "geneSymbol": "ADRA2C", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 152, + "officialSymbol": "ADRA2C", + "officialFullName": "adrenoceptor alpha 2C", + "uniprotAccessionNumber": "P18825" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2564617", + "pmid": 2564617, + "title": "[3H]L-657,743 (MK-912): a new, high affinity, selective radioligand for brain alpha 2-adrenoceptors", + "author": "Pettibone DJ, Flagg SD, Totaro JA, Clineschmidt BV, Huff JR, Young SD, Chen R", + "citation": "Pettibone DJ, Flagg SD, Totaro JA, Clineschmidt BV, Huff JR, Young SD, Chen R. [3H]L-657,743 (MK-912): a new, high affinity, selective radioligand for brain alpha 2-adrenoceptors. Life Sci. 1989;44(7):459-67. PubMed PMID: 2564617.", + "otherId": "0", + "citationId": 60, + "otherSource": "" + } + }, + { + "aeid": 630, + "assayComponentEndpointName": "NVS_GPCR_hAdrb1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hAdrb1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hAdrb1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene ADRB1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Alprenolol HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 367, + "assayComponentName": "NVS_GPCR_hAdrb1", + "assayComponentDesc": "NVS_GPCR_hAdrb1 is one of one assay component(s) measured or calculated from the NVS_GPCR_hAdrb1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-(-)-Iodocyanopindolol] are indicative of a change in receptor function and kinetics for the human adrenoceptor beta 1 [GeneSymbol:ADRB1 | GeneID:153 | Uniprot_SwissProt_Accession:P08588].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-(-)-Iodocyanopindolol", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 181, + "assayName": "NVS_GPCR_hAdrb1", + "assayDesc": "NVS_GPCR_hAdrb1 is a biochemical, single-readout assay that uses extracted gene-proteins from Human neuroepithelioma cells in a cell-free assay. Measurements were taken 2 hours after chemical dosing in a 96-well plate.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "Human neuroepithelioma cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 15, + "geneName": "adrenoceptor beta 1", + "description": null, + "geneSymbol": "ADRB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 153, + "officialSymbol": "ADRB1", + "officialFullName": "adrenoceptor beta 1", + "uniprotAccessionNumber": "P08588" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/39246", + "pmid": 39246, + "title": "Simultaneous determination of beta-1 and beta-2-adrenergic receptors in tissues containing both receptor subtypes", + "author": "Minneman KP, Hegstrand LR, Molinoff PB", + "citation": "Minneman KP, Hegstrand LR, Molinoff PB. Simultaneous determination of beta-1 and beta-2-adrenergic receptors in tissues containing both receptor subtypes. Mol Pharmacol. 1979 Jul;16(1):34-46. PubMed PMID: 39246.", + "otherId": "0", + "citationId": 2, + "otherSource": "" + } + }, + { + "aeid": 519, + "assayComponentEndpointName": "NVS_ENZ_hPKD2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPKD2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPKD2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PRKD2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 301, + "assayComponentName": "NVS_ENZ_hPKD2", + "assayComponentDesc": "NVS_ENZ_hPKD2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPKD2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human protein kinase D2 [GeneSymbol:PRKD2 | GeneID:25865 | Uniprot_SwissProt_Accession:Q9BZL6].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 115, + "assayName": "NVS_ENZ_hPKD2", + "assayDesc": "NVS_ENZ_hPKD2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 416, + "geneName": "protein kinase D2", + "description": null, + "geneSymbol": "PRKD2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 25865, + "officialSymbol": "PRKD2", + "officialFullName": "protein kinase D2", + "uniprotAccessionNumber": "Q9BZL6" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 521, + "assayComponentEndpointName": "NVS_ENZ_hPPM1A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPPM1A was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPPM1A, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PPM1A. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is serine/threonine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "sodium fluoride", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "serine/threonine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 302, + "assayComponentName": "NVS_ENZ_hPPM1A", + "assayComponentDesc": "NVS_ENZ_hPPM1A is one of one assay component(s) measured or calculated from the NVS_ENZ_hPPM1A assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:FDP(non-fluorescent) --> fluorescein + fluorescein monophosphate] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein phosphatase, Mg2+/Mn2+ dependent, 1A [GeneSymbol:PPM1A | GeneID:5494 | Uniprot_SwissProt_Accession:P35813].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 116, + "assayName": "NVS_ENZ_hPPM1A", + "assayDesc": "NVS_ENZ_hPPM1A is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 251, + "geneName": "protein phosphatase, Mg2+/Mn2+ dependent, 1A", + "description": null, + "geneSymbol": "PPM1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5494, + "officialSymbol": "PPM1A", + "officialFullName": "protein phosphatase, Mg2+/Mn2+ dependent, 1A", + "uniprotAccessionNumber": "P35813" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 523, + "assayComponentEndpointName": "NVS_ENZ_hPPP1CA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPPP1CA was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPPP1CA, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PPP1CA. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is serine/threonine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "calyculin A", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "serine/threonine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 303, + "assayComponentName": "NVS_ENZ_hPPP1CA", + "assayComponentDesc": "NVS_ENZ_hPPP1CA is one of one assay component(s) measured or calculated from the NVS_ENZ_hPPP1CA assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein phosphatase 1, catalytic subunit, alpha isozyme [GeneSymbol:PPP1CA | GeneID:5499 | Uniprot_SwissProt_Accession:P62136].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 117, + "assayName": "NVS_ENZ_hPPP1CA", + "assayDesc": "NVS_ENZ_hPPP1CA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.33 hours after chemical dosing in a 384-well plate.", + "timepointHr": 1.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 252, + "geneName": "protein phosphatase 1, catalytic subunit, alpha isozyme", + "description": null, + "geneSymbol": "PPP1CA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5499, + "officialSymbol": "PPP1CA", + "officialFullName": "protein phosphatase 1, catalytic subunit, alpha isozyme", + "uniprotAccessionNumber": "P62136" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7882291", + "pmid": 7882291, + "title": "Enhanced expression of catalytic subunit isoform PP1 gamma 1 of protein phosphatase type 1 associated with malignancy of osteogenic tumor", + "author": "Sogawa K, Yamada T, Oka S, Kawasaki K, Mori S, Tanaka H, Norimatsu H, Cai Y, Kuwabara H, Shima H, et al", + "citation": "Sogawa K, Yamada T, Oka S, Kawasaki K, Mori S, Tanaka H, Norimatsu H, Cai Y, Kuwabara H, Shima H, et al. Enhanced expression of catalytic subunit isoform PP1 gamma 1 of protein phosphatase type 1 associated with malignancy of osteogenic tumor. Cancer Lett. 1995 Feb 10;89(1):1-6. PubMed PMID: 7882291.", + "otherId": "0", + "citationId": 148, + "otherSource": "" + } + }, + { + "aeid": 525, + "assayComponentEndpointName": "NVS_ENZ_hPPP2CA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPPP2CA was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPPP2CA, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PPP2CA. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is serine/threonine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "calyculin A", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "serine/threonine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 304, + "assayComponentName": "NVS_ENZ_hPPP2CA", + "assayComponentDesc": "NVS_ENZ_hPPP2CA is one of one assay component(s) measured or calculated from the NVS_ENZ_hPPP2CA assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein phosphatase 2, catalytic subunit, alpha isozyme [GeneSymbol:PPP2CA | GeneID:5515 | Uniprot_SwissProt_Accession:P67775].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 118, + "assayName": "NVS_ENZ_hPPP2CA", + "assayDesc": "NVS_ENZ_hPPP2CA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.33 hours after chemical dosing in a 384-well plate.", + "timepointHr": 1.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 253, + "geneName": "protein phosphatase 2, catalytic subunit, alpha isozyme", + "description": null, + "geneSymbol": "PPP2CA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5515, + "officialSymbol": "PPP2CA", + "officialFullName": "protein phosphatase 2, catalytic subunit, alpha isozyme", + "uniprotAccessionNumber": "P67775" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/343651a0", + "url": "#http://www.ncbi.nlm.nih.gov/pubmed/2154696#", + "pmid": 2154696, + "title": "Requirement for integration of signals from two distinct phosphorylation pathways for activation of MAP kinase", + "author": "Anderson NG, Maller JL, Tonks NK, Sturgill TW", + "citation": "Anderson NG, Maller JL, Tonks NK, Sturgill TW. Requirement for integration of signals from two distinct phosphorylation pathways for activation of MAP kinase. Nature. 1990 Feb 15;343(6259):651-3. PubMed PMID: 2154696.", + "otherId": "0", + "citationId": 207, + "otherSource": "" + } + }, + { + "aeid": 527, + "assayComponentEndpointName": "NVS_ENZ_hPTEN", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTEN was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTEN, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTEN. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is dual-specific phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "bpV (bipy)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "dual-specific phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 305, + "assayComponentName": "NVS_ENZ_hPTEN", + "assayComponentDesc": "NVS_ENZ_hPTEN is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTEN assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-PIP3 --> fluorescein-PIP2] involving the key substrate [Fluorescein-labeled PIP3 (phosphoinositol triphosphate(3,4,5))] are indicative of changes in enzyme function and kinetics for the human phosphatase and tensin homolog [GeneSymbol:PTEN | GeneID:5728 | Uniprot_SwissProt_Accession:P60484].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled PIP3 (phosphoinositol triphosphate(3,4,5))", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 119, + "assayName": "NVS_ENZ_hPTEN", + "assayDesc": "NVS_ENZ_hPTEN is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 263, + "geneName": "phosphatase and tensin homolog", + "description": null, + "geneSymbol": "PTEN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5728, + "officialSymbol": "PTEN", + "officialFullName": "phosphatase and tensin homolog", + "uniprotAccessionNumber": "P60484" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 529, + "assayComponentEndpointName": "NVS_ENZ_hPTPN1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPN1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPN1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPN1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is non-receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "non-receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 306, + "assayComponentName": "NVS_ENZ_hPTPN1", + "assayComponentDesc": "NVS_ENZ_hPTPN1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPN1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human protein tyrosine phosphatase, non-receptor type 1 [GeneSymbol:PTPN1 | GeneID:5770 | Uniprot_SwissProt_Accession:P18031].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 120, + "assayName": "NVS_ENZ_hPTPN1", + "assayDesc": "NVS_ENZ_hPTPN1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.33 hours after chemical dosing in a 384-well plate.", + "timepointHr": 1.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 265, + "geneName": "protein tyrosine phosphatase, non-receptor type 1", + "description": null, + "geneSymbol": "PTPN1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5770, + "officialSymbol": "PTPN1", + "officialFullName": "protein tyrosine phosphatase, non-receptor type 1", + "uniprotAccessionNumber": "P18031" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1335746", + "pmid": 1335746, + "title": "1002 protein phosphatases?", + "author": "Charbonneau H, Tonks NK", + "citation": "Charbonneau H, Tonks NK. 1002 protein phosphatases? Annu Rev Cell Biol. 1992;8:463-93. Review. PubMed PMID: 1335746.", + "otherId": "0", + "citationId": 15, + "otherSource": "" + } + }, + { + "aeid": 531, + "assayComponentEndpointName": "NVS_ENZ_hPTPN11", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPN11 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPN11, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPN11. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is non-receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "non-receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 307, + "assayComponentName": "NVS_ENZ_hPTPN11", + "assayComponentDesc": "NVS_ENZ_hPTPN11 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPN11 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein tyrosine phosphatase, non-receptor type 11 [GeneSymbol:PTPN11 | GeneID:5781 | Uniprot_SwissProt_Accession:Q06124].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 121, + "assayName": "NVS_ENZ_hPTPN11", + "assayDesc": "NVS_ENZ_hPTPN11 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 384-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 270, + "geneName": "protein tyrosine phosphatase, non-receptor type 11", + "description": null, + "geneSymbol": "PTPN11", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5781, + "officialSymbol": "PTPN11", + "officialFullName": "protein tyrosine phosphatase, non-receptor type 11", + "uniprotAccessionNumber": "Q06124" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 533, + "assayComponentEndpointName": "NVS_ENZ_hPTPN12", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPN12 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPN12, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPN12. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is non-receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "non-receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 308, + "assayComponentName": "NVS_ENZ_hPTPN12", + "assayComponentDesc": "NVS_ENZ_hPTPN12 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPN12 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein tyrosine phosphatase, non-receptor type 12 [GeneSymbol:PTPN12 | GeneID:5782 | Uniprot_SwissProt_Accession:Q05209].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 122, + "assayName": "NVS_ENZ_hPTPN12", + "assayDesc": "NVS_ENZ_hPTPN12 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.33 hours after chemical dosing in a 384-well plate.", + "timepointHr": 1.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 271, + "geneName": "protein tyrosine phosphatase, non-receptor type 12", + "description": null, + "geneSymbol": "PTPN12", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5782, + "officialSymbol": "PTPN12", + "officialFullName": "protein tyrosine phosphatase, non-receptor type 12", + "uniprotAccessionNumber": "Q05209" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1943774", + "pmid": 1943774, + "title": "Use of vanadate as protein-phosphotyrosine phosphatase inhibitor", + "author": "Gordon JA", + "citation": "Gordon JA. Use of vanadate as protein-phosphotyrosine phosphatase inhibitor. Methods Enzymol. 1991;201:477-82. Review. PubMed PMID: 1943774.", + "otherId": "0", + "citationId": 26, + "otherSource": "" + } + }, + { + "aeid": 537, + "assayComponentEndpointName": "NVS_ENZ_hPTPN14", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPN14 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPN14, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPN14. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is non-receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "non-receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 310, + "assayComponentName": "NVS_ENZ_hPTPN14", + "assayComponentDesc": "NVS_ENZ_hPTPN14 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPN14 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein tyrosine phosphatase, non-receptor type 14 [GeneSymbol:PTPN14 | GeneID:5784 | Uniprot_SwissProt_Accession:Q15678].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 124, + "assayName": "NVS_ENZ_hPTPN14", + "assayDesc": "NVS_ENZ_hPTPN14 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 384-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 273, + "geneName": "protein tyrosine phosphatase, non-receptor type 14", + "description": null, + "geneSymbol": "PTPN14", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5784, + "officialSymbol": "PTPN14", + "officialFullName": "protein tyrosine phosphatase, non-receptor type 14", + "uniprotAccessionNumber": "Q15678" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 539, + "assayComponentEndpointName": "NVS_ENZ_hPTPN2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPN2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPN2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPN2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is non-receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "non-receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 311, + "assayComponentName": "NVS_ENZ_hPTPN2", + "assayComponentDesc": "NVS_ENZ_hPTPN2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPN2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein kinase, AMP-activated, gamma 1 non-catalytic subunit [GeneSymbol:PRKAG1 | GeneID:5571 | Uniprot_SwissProt_Accession:P54619].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 125, + "assayName": "NVS_ENZ_hPTPN2", + "assayDesc": "NVS_ENZ_hPTPN2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 266, + "geneName": "protein tyrosine phosphatase, non-receptor type 2", + "description": null, + "geneSymbol": "PTPN2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5771, + "officialSymbol": "PTPN2", + "officialFullName": "protein tyrosine phosphatase, non-receptor type 2", + "uniprotAccessionNumber": "P17706" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1943774", + "pmid": 1943774, + "title": "Use of vanadate as protein-phosphotyrosine phosphatase inhibitor", + "author": "Gordon JA", + "citation": "Gordon JA. Use of vanadate as protein-phosphotyrosine phosphatase inhibitor. Methods Enzymol. 1991;201:477-82. Review. PubMed PMID: 1943774.", + "otherId": "0", + "citationId": 26, + "otherSource": "" + } + }, + { + "aeid": 541, + "assayComponentEndpointName": "NVS_ENZ_hPTPN4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPN4 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPN4, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPN4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is non-receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "non-receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 312, + "assayComponentName": "NVS_ENZ_hPTPN4", + "assayComponentDesc": "NVS_ENZ_hPTPN4 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPN4 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein tyrosine phosphatase, non-receptor type 4 (megakaryocyte) [GeneSymbol:PTPN4 | GeneID:5775 | Uniprot_SwissProt_Accession:P29074].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 126, + "assayName": "NVS_ENZ_hPTPN4", + "assayDesc": "NVS_ENZ_hPTPN4 is a biochemical, single-readout assay that uses extracted gene-proteins from SF9 in a cell-free assay. Measurements were taken 1.33 hours after chemical dosing in a 384-well plate.", + "timepointHr": 1.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "SF9", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 267, + "geneName": "protein tyrosine phosphatase, non-receptor type 4 (megakaryocyte)", + "description": null, + "geneSymbol": "PTPN4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5775, + "officialSymbol": "PTPN4", + "officialFullName": "protein tyrosine phosphatase, non-receptor type 4 (megakaryocyte)", + "uniprotAccessionNumber": "P29074" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 543, + "assayComponentEndpointName": "NVS_ENZ_hPTPN6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPN6 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPN6, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPN6. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is non-receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "non-receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 313, + "assayComponentName": "NVS_ENZ_hPTPN6", + "assayComponentDesc": "NVS_ENZ_hPTPN6 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPN6 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein tyrosine phosphatase, non-receptor type 6 [GeneSymbol:PTPN6 | GeneID:5777 | Uniprot_SwissProt_Accession:P29350].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 127, + "assayName": "NVS_ENZ_hPTPN6", + "assayDesc": "NVS_ENZ_hPTPN6 is a biochemical, single-readout assay that uses extracted gene-proteins from SF9 in a cell-free assay. Measurements were taken 1.33 hours after chemical dosing in a 384-well plate.", + "timepointHr": 1.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "SF9", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 268, + "geneName": "protein tyrosine phosphatase, non-receptor type 6", + "description": null, + "geneSymbol": "PTPN6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5777, + "officialSymbol": "PTPN6", + "officialFullName": "protein tyrosine phosphatase, non-receptor type 6", + "uniprotAccessionNumber": "P29350" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 545, + "assayComponentEndpointName": "NVS_ENZ_hPTPN9", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPN9 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPN9, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPN9. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is non-receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "non-receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 314, + "assayComponentName": "NVS_ENZ_hPTPN9", + "assayComponentDesc": "NVS_ENZ_hPTPN9 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPN9 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein tyrosine phosphatase, non-receptor type 9 [GeneSymbol:PTPN9 | GeneID:5780 | Uniprot_SwissProt_Accession:P43378].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 128, + "assayName": "NVS_ENZ_hPTPN9", + "assayDesc": "NVS_ENZ_hPTPN9 is a biochemical, single-readout assay that uses extracted gene-proteins from SF9 in a cell-free assay. Measurements were taken 1.33 hours after chemical dosing in a 384-well plate.", + "timepointHr": 1.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "SF9", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 269, + "geneName": "protein tyrosine phosphatase, non-receptor type 9", + "description": null, + "geneSymbol": "PTPN9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5780, + "officialSymbol": "PTPN9", + "officialFullName": "protein tyrosine phosphatase, non-receptor type 9", + "uniprotAccessionNumber": "P43378" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 547, + "assayComponentEndpointName": "NVS_ENZ_hPTPRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPRB was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPRB, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPRB. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 315, + "assayComponentName": "NVS_ENZ_hPTPRB", + "assayComponentDesc": "NVS_ENZ_hPTPRB is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPRB assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human protein tyrosine phosphatase, receptor type, B [GeneSymbol:PTPRB | GeneID:5787 | Uniprot_SwissProt_Accession:P23467].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 129, + "assayName": "NVS_ENZ_hPTPRB", + "assayDesc": "NVS_ENZ_hPTPRB is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 274, + "geneName": "protein tyrosine phosphatase, receptor type, B", + "description": null, + "geneSymbol": "PTPRB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5787, + "officialSymbol": "PTPRB", + "officialFullName": "protein tyrosine phosphatase, receptor type, B", + "uniprotAccessionNumber": "P23467" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1335746", + "pmid": 1335746, + "title": "1002 protein phosphatases?", + "author": "Charbonneau H, Tonks NK", + "citation": "Charbonneau H, Tonks NK. 1002 protein phosphatases? Annu Rev Cell Biol. 1992;8:463-93. Review. PubMed PMID: 1335746.", + "otherId": "0", + "citationId": 15, + "otherSource": "" + } + }, + { + "aeid": 549, + "assayComponentEndpointName": "NVS_ENZ_hPTPRC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPRC was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPRC, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPRC. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 316, + "assayComponentName": "NVS_ENZ_hPTPRC", + "assayComponentDesc": "NVS_ENZ_hPTPRC is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPRC assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by Colorimetric technology.", + "assayComponentTargetDesc": "Changes to absorbance signals produced from an enzymatic reaction [Reaction:pNPP --> p-nitrophenol] involving the key substrate [para-Nitrophenylphosphate (pNPP)] are indicative of changes in enzyme function and kinetics for the human protein tyrosine phosphatase, receptor type, C [GeneSymbol:PTPRC | GeneID:5788 | Uniprot_SwissProt_Accession:P08575].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Colorimetric", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "para-Nitrophenylphosphate (pNPP)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 130, + "assayName": "NVS_ENZ_hPTPRC", + "assayDesc": "NVS_ENZ_hPTPRC is a biochemical, single-readout assay that uses extracted gene-proteins from yeast cells in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "yeast cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 275, + "geneName": "protein tyrosine phosphatase, receptor type, C", + "description": null, + "geneSymbol": "PTPRC", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5788, + "officialSymbol": "PTPRC", + "officialFullName": "protein tyrosine phosphatase, receptor type, C", + "uniprotAccessionNumber": "P08575" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/8031864", + "pmid": 8031864, + "title": "High level expression and purification of the enzymatically active cytoplasmic region of human CD45 phosphatase from yeast", + "author": "Pacitti A, Stevis P, Evans M, Trowbridge I, Higgins TJ", + "citation": "Pacitti A, Stevis P, Evans M, Trowbridge I, Higgins TJ. High level expression and purification of the enzymatically active cytoplasmic region of human CD45 phosphatase from yeast. Biochim Biophys Acta. 1994 Jun 30;1222(2):277-86. PubMed PMID: 8031864.", + "otherId": "0", + "citationId": 153, + "otherSource": "" + } + }, + { + "aeid": 1921, + "assayComponentEndpointName": "ATG_zfAR_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfAR_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1860, + "assayComponentName": "ATG_zfAR_XSP1", + "assayComponentDesc": "ATG_zfAR_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element AR, which is responsive to the zebrafish androgen receptor. [GeneSymbol:AR | GeneID:100005148 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfAR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1467, + "geneName": "androgen receptor", + "description": "androgen receptor [Danio rerio (zebrafish)]", + "geneSymbol": "ar", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 100005148, + "officialSymbol": "ar", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "A4GT83" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1923, + "assayComponentEndpointName": "ATG_frER1_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frER1_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1861, + "assayComponentName": "ATG_frER1_XSP1", + "assayComponentDesc": "ATG_frER1_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the frog estrogen receptor. [GeneSymbol:esr1.L | GeneID: 398734 | Uniprot_SwissProt_Accession:Q6W5G7].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frER1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1480, + "geneName": "estrogen receptor 1 L homeolog", + "description": "estrogen receptor 1 L homeolog [Xenopus laevis (African clawed frog)]", + "geneSymbol": "esr1.L", + "organismId": 46, + "trackStatus": null, + "entrezGeneId": 398734, + "officialSymbol": "esr1.L", + "officialFullName": "estrogen receptor 1 L homeolog", + "uniprotAccessionNumber": "Q6W5G7" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1925, + "assayComponentEndpointName": "ATG_zfER1_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfER1_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1862, + "assayComponentName": "ATG_zfER1_XSP1", + "assayComponentDesc": "ATG_zfER1_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the zebrafish estrogen receptor. [GeneSymbol:esr1 | GeneID: 259252| Uniprot_SwissProt_Accession:P57717].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfER1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1468, + "geneName": "estrogen receptor 1", + "description": "estrogen receptor [Danio rerio (zebrafish)]", + "geneSymbol": "esr1", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 259252, + "officialSymbol": "esr1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P57717" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1927, + "assayComponentEndpointName": "ATG_zfER2a_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfER2a_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1863, + "assayComponentName": "ATG_zfER2a_XSP1", + "assayComponentDesc": "ATG_zfER2a_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the zebrafish estrogen receptor. [GeneSymbol:esr2a | GeneID: 317734| Uniprot_SwissProt_Accession:Q7ZU32].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfER2a RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1469, + "geneName": "estrogen receptor 2a", + "description": "estrogen receptor 2a [ Danio rerio (zebrafish) ]", + "geneSymbol": "esr2a", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 317734, + "officialSymbol": "esr2a", + "officialFullName": "estrogen receptor 2a", + "uniprotAccessionNumber": "Q7ZU32" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1929, + "assayComponentEndpointName": "ATG_zfER2b_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_zfER2b_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1864, + "assayComponentName": "ATG_zfER2b_XSP1", + "assayComponentDesc": "ATG_zfER2b_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the zebrafish estrogen receptor. [GeneSymbol:esr2b | GeneID: 317733| Uniprot_SwissProt_Accession:Q5PR29].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-zfER2b RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1470, + "geneName": "estrogen receptor 2b", + "description": "estrogen receptor 2b [ Danio rerio (zebrafish) ]", + "geneSymbol": "esr2b", + "organismId": 43, + "trackStatus": null, + "entrezGeneId": 317733, + "officialSymbol": "esr2b", + "officialFullName": "estrogen receptor 2b", + "uniprotAccessionNumber": "Q5PR29" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1931, + "assayComponentEndpointName": "ATG_frER2_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_frER2_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1865, + "assayComponentName": "ATG_frER2_XSP1", + "assayComponentDesc": "ATG_frER2_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the frog estrogen receptor. [GeneSymbol:esr2.L | GeneID: 100174814| Uniprot_SwissProt_Accession:A0A1L8FA50].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-frER2 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1481, + "geneName": "estrogen receptor 2 L homeolog", + "description": "estrogen receptor 2 L homeolog [ Xenopus laevis (African clawed frog) ]", + "geneSymbol": "esr2.L", + "organismId": 46, + "trackStatus": null, + "entrezGeneId": 100174814, + "officialSymbol": "esr2.L", + "officialFullName": "estrogen receptor 2 L homeolog", + "uniprotAccessionNumber": "A0A1L8FA50" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1933, + "assayComponentEndpointName": "ATG_chERa_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_chERa_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1866, + "assayComponentName": "ATG_chERa_XSP1", + "assayComponentDesc": "ATG_chERa_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the chicken estrogen receptor. [GeneSymbol:ESR1 | GeneID: 396099| Uniprot_SwissProt_Accession:P06212].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-chERa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1475, + "geneName": "estrogen receptor 1", + "description": "estrogen receptor 1 (chicken)", + "geneSymbol": "ESR1", + "organismId": 45, + "trackStatus": null, + "entrezGeneId": 396099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P06212" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1935, + "assayComponentEndpointName": "ATG_hERa_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hERa_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1867, + "assayComponentName": "ATG_hERa_XSP1", + "assayComponentDesc": "ATG_hERa_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the human estrogen receptor. [GeneSymbol:ESR1 | GeneID: 2099| Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-ERa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1937, + "assayComponentEndpointName": "ATG_trERa_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_trERa_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1868, + "assayComponentName": "ATG_trERa_XSP1", + "assayComponentDesc": "ATG_trERa_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the turtle estrogen receptor. [GeneSymbol:ESR1 | GeneID: 101933533| Uniprot_SwissProt_Accession:B6E1V9].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-trERa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 1465, + "geneName": "estrogen receptor 1", + "description": "estrogen receptor 1 [ Chrysemys picta (painted turtle) ]", + "geneSymbol": "ESR1", + "organismId": 42, + "trackStatus": null, + "entrezGeneId": 101933533, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "B6E1V9" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1939, + "assayComponentEndpointName": "ATG_hERb_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint ATG_hERb_XSP1 was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ER. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1869, + "assayComponentName": "ATG_hERb_XSP1", + "assayComponentDesc": "ATG_hERb_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the trans-acting reporter gene response element ER, which is responsive to the human estrogen receptor. [GeneSymbol:ESR2 | GeneID: 2100| Uniprot_SwissProt_Accession:Q92731].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-ERb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 118, + "geneName": "estrogen receptor 2 (ER beta)", + "description": null, + "geneSymbol": "ESR2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2100, + "officialSymbol": "ESR2", + "officialFullName": "estrogen receptor 2 (ER beta)", + "uniprotAccessionNumber": "Q92731" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 1941, + "assayComponentEndpointName": "ATG_GAL4_XSP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "This assay endpoint, ATG_GAL4_XSP1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is baseline control.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1870, + "assayComponentName": "ATG_GAL4_XSP1", + "assayComponentDesc": "ATG_GAL4_XSP1 is one of 29 assay components measured or calculated from the ATG_XSP1_multi-species_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "gal4-gal4 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 569, + "assayName": "ATG_XSP1_multi-species_TRANS", + "assayDesc": "ATG_XSP1_multi-species_TRANS is a cell-based, multiplexed assay created by modifying the existing Attagene TRANS-FACTORIAL system to include a panel of nuclear receptors from some or all the following species: human (Homo sapiens), mouse (Mus musculus), frog (Xenopus laevis), zebrafish (Danio rerio), chicken (Gallus gallus), and turtle (Chrysemys picta). The ECOTOX-FACTORIAL format uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate. Xsp1 included 3 nM 6-alpha-fluorotestosterone to partially stimulate the androgen receptor.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 466, + "geneName": "Gal4p", + "description": "provisional", + "geneSymbol": "GAL4", + "organismId": 8, + "trackStatus": "live", + "entrezGeneId": 855828, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P04386" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1016/j.tiv.2020.105016", + "url": "https://pubmed.ncbi.nlm.nih.gov/33049310/", + "pmid": 33049310, + "title": "Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment.", + "author": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S", + "citation": "Houck KA, Simha A, Bone A, Doering JA, Vliet SMF, LaLone C, Medvedev A, Makarov S. Evaluation of a multiplexed, multispecies nuclear receptor assay for chemical hazard assessment. Toxicol In Vitro. 2021 Apr;72:105016. doi: 10.1016/j.tiv.2020.105016. Epub 2020 Oct 10. PMID: 33049310.", + "otherId": "0", + "citationId": 237, + "otherSource": "" + } + }, + { + "aeid": 631, + "assayComponentEndpointName": "NVS_GPCR_hAdrb2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hAdrb2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hAdrb2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene ADRB2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Alprenolol HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 368, + "assayComponentName": "NVS_GPCR_hAdrb2", + "assayComponentDesc": "NVS_GPCR_hAdrb2 is one of one assay component(s) measured or calculated from the NVS_GPCR_hAdrb2 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-(-)-Iodocyanopindolol] are indicative of a change in receptor function and kinetics for the human adrenoceptor beta 2, surface [GeneSymbol:ADRB2 | GeneID:154 | Uniprot_SwissProt_Accession:P07550].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-(-)-Iodocyanopindolol", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 182, + "assayName": "NVS_GPCR_hAdrb2", + "assayDesc": "NVS_GPCR_hAdrb2 is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 16, + "geneName": "adrenoceptor beta 2, surface", + "description": null, + "geneSymbol": "ADRB2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 154, + "officialSymbol": "ADRB2", + "officialFullName": "adrenoceptor beta 2, surface", + "uniprotAccessionNumber": "P07550" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/39246", + "pmid": 39246, + "title": "Simultaneous determination of beta-1 and beta-2-adrenergic receptors in tissues containing both receptor subtypes", + "author": "Minneman KP, Hegstrand LR, Molinoff PB", + "citation": "Minneman KP, Hegstrand LR, Molinoff PB. Simultaneous determination of beta-1 and beta-2-adrenergic receptors in tissues containing both receptor subtypes. Mol Pharmacol. 1979 Jul;16(1):34-46. PubMed PMID: 39246.", + "otherId": "0", + "citationId": 2, + "otherSource": "" + } + }, + { + "aeid": 2, + "assayComponentEndpointName": "ACEA_ER_80hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ACEA_ER_80hr was analyzed into 1 assay endpoint. \r\nThis assay endpoint, ACEA_ER_80hr_Positive, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of growth reporter, measures of the cells for gain-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene ESR1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "signaling", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 1, + "assayComponentName": "ACEA_ER_80hr", + "assayComponentDesc": "ACEA_ER_80hr is one of two assay component(s) measured or calculated from the ACEA_ER assay. It is designed to make measurements of real-time cell-growth kinetics, a form of growth reporter, as detected with electrical impedance signals by Real-Time Cell Electrode Sensor (RT-CES) technology.", + "assayComponentTargetDesc": "Electrical impedance is used to quantify changes to the growth of the cells where increase impedance is positively correlated with increased cell growth", + "parameterReadoutType": "single", + "assayDesignType": "growth reporter", + "assayDesignTypeSub": "real-time cell-growth kinetics", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Label Free Technology", + "detectionTechnologyTypeSub": "Electrical Sensor: Impedance", + "detectionTechnology": "RT-CES", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "cellular", + "aid": 1, + "assayName": "ACEA_ER", + "assayDesc": "ACEA_ER is a cell-based, single-readout assay that uses T47D, a human breast cell line, with measurements taken at 80 hours after chemical dosing in a 96-well or 384-well plate.", + "timepointHr": 80.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "T47D", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 1, + "assaySourceName": "ACEA", + "assaySourceLongName": "ACEA Biosciences", + "assaySourceDesc": "ACEA Biosciences, Inc. (ACEA) is a privately owned biotechnology company that developed a real-time, label-free, cell growth assay system called xCELLigence based on a microelectronic impedance readout .", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16481145", + "pmid": 16481145, + "title": "Microelectronic cell sensor assay for detection of cytotoxicity and prediction of acute toxicity", + "author": "Xing JZ, Zhu L, Gabos S, Xie L", + "citation": "Xing JZ, Zhu L, Gabos S, Xie L. Microelectronic cell sensor assay for detection of cytotoxicity and prediction of acute toxicity. Toxicol In Vitro. 2006 Sep;20(6):995-1004. Epub 2006 Feb 14. PubMed PMID: 16481145.", + "otherId": "0", + "citationId": 209, + "otherSource": "" + } + }, + { + "aeid": 4, + "assayComponentEndpointName": "APR_HepG2_CellCycleArrest_1hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_CellCycleArrest_1hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_CellCycleArrest_1hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, measures of all nuclear dna for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene . \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is arrest.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "arrest", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2, + "assayComponentName": "APR_HepG2_CellCycleArrest_1hr", + "assayComponentDesc": "APR_HepG2_CellCycleArrest_1hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_1hr assay. It is designed to make measurements of cell phenotype, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Hoechst-33342 dye is used as a stain for DNA to understand morphology in the system.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst-33342 dye", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 2, + "assayName": "APR_HepG2_1hr", + "assayDesc": "APR_HepG2_1hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 6, + "assayComponentEndpointName": "APR_HepG2_CellLoss_1hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_CellLoss_1hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_CellLoss_1hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of all nuclear dna for gain or loss-of-signal activity can be used to understand the viability at the cellular-level. \nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is proliferation.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin;Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 3, + "assayComponentName": "APR_HepG2_CellLoss_1hr", + "assayComponentDesc": "APR_HepG2_CellLoss_1hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_1hr assay. It is designed to make measurements of cell number, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Hoechst-33342 dye is used as a stain for DNA to understand viability in the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell number", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst-33342 dye", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 2, + "assayName": "APR_HepG2_1hr", + "assayDesc": "APR_HepG2_1hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 8, + "assayComponentEndpointName": "APR_HepG2_MicrotubuleCSK_1hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_MicrotubuleCSK_1hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_MicrotubuleCSK_1hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of conformation reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the cellular-level. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is cell conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin;Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 4, + "assayComponentName": "APR_HepG2_MicrotubuleCSK_1hr", + "assayComponentDesc": "APR_HepG2_MicrotubuleCSK_1hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_1hr assay. It is designed to make measurements of protein conformation, a form of conformation reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "anti-a-tubulin antibody is used to tag and quantify the level of tubulin, alpha 1a protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:TUBA1A | GeneID:7846 | Uniprot_SwissProt_Accession:Q71U36].", + "parameterReadoutType": "single", + "assayDesignType": "conformation reporter", + "assayDesignTypeSub": "protein conformation", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-a-tubulin antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 2, + "assayName": "APR_HepG2_1hr", + "assayDesc": "APR_HepG2_1hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 339, + "geneName": "tubulin, alpha 1a", + "description": null, + "geneSymbol": "TUBA1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7846, + "officialSymbol": "TUBA1A", + "officialFullName": "tubulin, alpha 1a", + "uniprotAccessionNumber": "Q71U36" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 10, + "assayComponentEndpointName": "APR_HepG2_MitoMass_1hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_MitoMass_1hr was analyzed into 1 assay endpoint. This assay endpoint, APR_HepG2_MitoMass_1hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is organelle conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin;Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "organelle conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 5, + "assayComponentName": "APR_HepG2_MitoMass_1hr", + "assayComponentDesc": "APR_HepG2_MitoMass_1hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_1hr assay. It is designed to make measurements of cell phenotype, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "MitoTracker Red is used as a stain for the morphology of the mitochondria.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "MitoTracker Red", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 2, + "assayName": "APR_HepG2_1hr", + "assayDesc": "APR_HepG2_1hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 12, + "assayComponentEndpointName": "APR_HepG2_MitoMembPot_1hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_MitoMembPot_1hr was analyzed into 1 assay endpoint. This assay endpoint, APR_HepG2_MitoMembPot_1hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of membrane potential reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is organelle conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin;Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "organelle conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 6, + "assayComponentName": "APR_HepG2_MitoMembPot_1hr", + "assayComponentDesc": "APR_HepG2_MitoMembPot_1hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_1hr assay. It is designed to make measurements of dye binding, a form of membrane potential reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "MitoTracker Red is used as a stain for the membrane potential of the mitochondria.", + "parameterReadoutType": "single", + "assayDesignType": "membrane potential reporter", + "assayDesignTypeSub": "dye binding", + "biologicalProcessTarget": "mitochondrial depolarization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "MitoTracker Red", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 2, + "assayName": "APR_HepG2_1hr", + "assayDesc": "APR_HepG2_1hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 14, + "assayComponentEndpointName": "APR_HepG2_MitoticArrest_1hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_MitoticArrest_1hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_MitoticArrest_1hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene . \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is arrest.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin;Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "arrest", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 7, + "assayComponentName": "APR_HepG2_MitoticArrest_1hr", + "assayComponentDesc": "APR_HepG2_MitoticArrest_1hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_1hr assay. It is designed to make measurements of cell phenotype, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "anti-phospho-histone-H3 antibody is used to tag and quantify the level of phosphorylated H3 histone, family 3A protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:H3F3A | GeneID:3020 | Uniprot_SwissProt_Accession:P84243].", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-phospho-histone-H3 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 2, + "assayName": "APR_HepG2_1hr", + "assayDesc": "APR_HepG2_1hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 150, + "geneName": "H3 histone, family 3A", + "description": null, + "geneSymbol": "H3F3A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3020, + "officialSymbol": "H3F3A", + "officialFullName": "H3 histone, family 3A", + "uniprotAccessionNumber": "P84243" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 16, + "assayComponentEndpointName": "APR_HepG2_NuclearSize_1hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_NuclearSize_1hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_NuclearSize_1hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, measures of all nuclear dna for gain or loss-of-signal activity can be used to understand the signaling at the nuclear-level. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is organelle conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin;Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "organelle conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 8, + "assayComponentName": "APR_HepG2_NuclearSize_1hr", + "assayComponentDesc": "APR_HepG2_NuclearSize_1hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_1hr assay. It is designed to make measurements of cell phenotype, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Hoechst-33342 dye is used as a stain for DNA to understand morphology in the system.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst-33342 dye", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 2, + "assayName": "APR_HepG2_1hr", + "assayDesc": "APR_HepG2_1hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 18, + "assayComponentEndpointName": "APR_HepG2_P-H2AX_1hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_P-H2AX_1hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_P-H2AX_1hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene . \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is cellular response to DNA damage stimulus.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "cellular response to DNA damage stimulus", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 9, + "assayComponentName": "APR_HepG2_P-H2AX_1hr", + "assayComponentDesc": "APR_HepG2_P-H2AX_1hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_1hr assay. It is designed to make measurements of dna content, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Anti-phospho-histone-H2AX antibody is used to tag and quantify the level of phosphorylated H2A histone family, member X protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:H2AFX | GeneID:3014 | Uniprot_SwissProt_Accession:P16104].", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dna content", + "biologicalProcessTarget": "oxidative phosphorylation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-phospho-histone-H2AX antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 2, + "assayName": "APR_HepG2_1hr", + "assayDesc": "APR_HepG2_1hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 149, + "geneName": "H2A histone family, member X", + "description": null, + "geneSymbol": "H2AFX", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3014, + "officialSymbol": "H2AFX", + "officialFullName": "H2A histone family, member X", + "uniprotAccessionNumber": "P16104" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 20, + "assayComponentEndpointName": "APR_HepG2_p53Act_1hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_p53Act_1hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_p53Act_1hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene TP53. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is tumor suppressor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "tumor suppressor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 10, + "assayComponentName": "APR_HepG2_p53Act_1hr", + "assayComponentDesc": "APR_HepG2_p53Act_1hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_1hr assay. It is designed to make measurements of dna content, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "anti-p53 antibody is used to tag and quantify the level of tumor protein p53 protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:TP53 | GeneID:7157 | Uniprot_SwissProt_Accession:P04637].", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dna content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-p53 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 2, + "assayName": "APR_HepG2_1hr", + "assayDesc": "APR_HepG2_1hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 329, + "geneName": "tumor protein p53", + "description": null, + "geneSymbol": "TP53", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7157, + "officialSymbol": "TP53", + "officialFullName": "tumor protein p53", + "uniprotAccessionNumber": "P04637" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 22, + "assayComponentEndpointName": "APR_HepG2_StressKinase_1hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_StressKinase_1hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_StressKinase_1hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of enzyme reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene . \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is stress response.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "stress response", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 11, + "assayComponentName": "APR_HepG2_StressKinase_1hr", + "assayComponentDesc": "APR_HepG2_StressKinase_1hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_1hr assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "anti-phospho-c-jun antibody is used to tag and quantify the level of phosphorylated jun proto-oncogene protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:JUN | GeneID:3725 | Uniprot_SwissProt_Accession:P05412].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "oxidative phosphorylation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-phospho-c-jun antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 2, + "assayName": "APR_HepG2_1hr", + "assayDesc": "APR_HepG2_1hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 183, + "geneName": "jun proto-oncogene", + "description": null, + "geneSymbol": "JUN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3725, + "officialSymbol": "JUN", + "officialFullName": "jun proto-oncogene", + "uniprotAccessionNumber": "P05412" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 24, + "assayComponentEndpointName": "APR_HepG2_CellCycleArrest_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_CellCycleArrest_24hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_CellCycleArrest_24hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, measures of all nuclear dna for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene . \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is arrest.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "arrest", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 12, + "assayComponentName": "APR_HepG2_CellCycleArrest_24hr", + "assayComponentDesc": "APR_HepG2_CellCycleArrest_24hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_24hr assay. It is designed to make measurements of cell phenotype, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Hoechst-33342 dye is used as a stain for DNA to understand morphology in the system.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst-33342 dye", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 3, + "assayName": "APR_HepG2_24hr", + "assayDesc": "APR_HepG2_24hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 26, + "assayComponentEndpointName": "APR_HepG2_CellLoss_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_CellLoss_24hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_CellLoss_24hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of all nuclear dna for gain or loss-of-signal activity can be used to understand the viability at the cellular-level. \nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is proliferation.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin;Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 13, + "assayComponentName": "APR_HepG2_CellLoss_24hr", + "assayComponentDesc": "APR_HepG2_CellLoss_24hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_24hr assay. It is designed to make measurements of cell number, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Hoechst-33342 dye is used as a stain for DNA to understand viability in the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell number", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst-33342 dye", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 3, + "assayName": "APR_HepG2_24hr", + "assayDesc": "APR_HepG2_24hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 28, + "assayComponentEndpointName": "APR_HepG2_MicrotubuleCSK_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_MicrotubuleCSK_24hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_MicrotubuleCSK_24hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of conformation reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the cellular-level. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is cell conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 14, + "assayComponentName": "APR_HepG2_MicrotubuleCSK_24hr", + "assayComponentDesc": "APR_HepG2_MicrotubuleCSK_24hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_24hr assay. It is designed to make measurements of protein conformation, a form of conformation reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "anti-a-tubulin antibody is used to tag and quantify the level of tubulin, alpha 1a protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:TUBA1A | GeneID:7846 | Uniprot_SwissProt_Accession:Q71U36].", + "parameterReadoutType": "single", + "assayDesignType": "conformation reporter", + "assayDesignTypeSub": "protein conformation", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-a-tubulin antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 3, + "assayName": "APR_HepG2_24hr", + "assayDesc": "APR_HepG2_24hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 339, + "geneName": "tubulin, alpha 1a", + "description": null, + "geneSymbol": "TUBA1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7846, + "officialSymbol": "TUBA1A", + "officialFullName": "tubulin, alpha 1a", + "uniprotAccessionNumber": "Q71U36" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 30, + "assayComponentEndpointName": "APR_HepG2_MitoMass_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_MitoMass_24hr was analyzed into 1 assay endpoint. This assay endpoint, APR_HepG2_MitoMass_24hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is organelle conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "organelle conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 15, + "assayComponentName": "APR_HepG2_MitoMass_24hr", + "assayComponentDesc": "APR_HepG2_MitoMass_24hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_24hr assay. It is designed to make measurements of cell phenotype, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "MitoTracker Red is used as a stain for the morphology of the mitochondria.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "MitoTracker Red", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 3, + "assayName": "APR_HepG2_24hr", + "assayDesc": "APR_HepG2_24hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 32, + "assayComponentEndpointName": "APR_HepG2_MitoMembPot_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_MitoMembPot_24hr was analyzed into 1 assay endpoint. This assay endpoint, APR_HepG2_MitoMembPot_24hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of membrane potential reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is organelle conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "organelle conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 16, + "assayComponentName": "APR_HepG2_MitoMembPot_24hr", + "assayComponentDesc": "APR_HepG2_MitoMembPot_24hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_24hr assay. It is designed to make measurements of dye binding, a form of membrane potential reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "MitoTracker Red is used as a stain for the membrane potential of the mitochondria.", + "parameterReadoutType": "single", + "assayDesignType": "membrane potential reporter", + "assayDesignTypeSub": "dye binding", + "biologicalProcessTarget": "mitochondrial depolarization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "MitoTracker Red", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 3, + "assayName": "APR_HepG2_24hr", + "assayDesc": "APR_HepG2_24hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 34, + "assayComponentEndpointName": "APR_HepG2_MitoticArrest_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_MitoticArrest_24hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_MitoticArrest_24hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene . \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is arrest.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "arrest", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 17, + "assayComponentName": "APR_HepG2_MitoticArrest_24hr", + "assayComponentDesc": "APR_HepG2_MitoticArrest_24hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_24hr assay. It is designed to make measurements of cell phenotype, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "anti-phospho-histone-H3 antibody is used to tag and quantify the level of phosphorylated H3 histone, family 3A protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:H3F3A | GeneID:3020 | Uniprot_SwissProt_Accession:P84243].", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-phospho-histone-H3 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 3, + "assayName": "APR_HepG2_24hr", + "assayDesc": "APR_HepG2_24hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 150, + "geneName": "H3 histone, family 3A", + "description": null, + "geneSymbol": "H3F3A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3020, + "officialSymbol": "H3F3A", + "officialFullName": "H3 histone, family 3A", + "uniprotAccessionNumber": "P84243" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 36, + "assayComponentEndpointName": "APR_HepG2_NuclearSize_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_NuclearSize_24hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_NuclearSize_24hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, measures of all nuclear dna for gain or loss-of-signal activity can be used to understand the signaling at the nuclear-level. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is organelle conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "organelle conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 18, + "assayComponentName": "APR_HepG2_NuclearSize_24hr", + "assayComponentDesc": "APR_HepG2_NuclearSize_24hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_24hr assay. It is designed to make measurements of cell phenotype, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Hoechst-33342 dye is used as a stain for DNA to understand morphology in the system.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst-33342 dye", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 3, + "assayName": "APR_HepG2_24hr", + "assayDesc": "APR_HepG2_24hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 38, + "assayComponentEndpointName": "APR_HepG2_P-H2AX_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_P-H2AX_24hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_P-H2AX_24hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene . \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is cellular response to DNA damage stimulus.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "cellular response to DNA damage stimulus", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 19, + "assayComponentName": "APR_HepG2_P-H2AX_24hr", + "assayComponentDesc": "APR_HepG2_P-H2AX_24hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_24hr assay. It is designed to make measurements of dna content, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Anti-phospho-histone-H2AX antibody is used to tag and quantify the level of phosphorylated H2A histone family, member X protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:H2AFX | GeneID:3014 | Uniprot_SwissProt_Accession:P16104].", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dna content", + "biologicalProcessTarget": "oxidative phosphorylation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-phospho-histone-H2AX antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 3, + "assayName": "APR_HepG2_24hr", + "assayDesc": "APR_HepG2_24hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 149, + "geneName": "H2A histone family, member X", + "description": null, + "geneSymbol": "H2AFX", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3014, + "officialSymbol": "H2AFX", + "officialFullName": "H2A histone family, member X", + "uniprotAccessionNumber": "P16104" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 40, + "assayComponentEndpointName": "APR_HepG2_p53Act_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_p53Act_24hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_p53Act_24hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene TP53. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is tumor suppressor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "tumor suppressor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 20, + "assayComponentName": "APR_HepG2_p53Act_24hr", + "assayComponentDesc": "APR_HepG2_p53Act_24hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_24hr assay. It is designed to make measurements of dna content, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "anti-p53 antibody is used to tag and quantify the level of tumor protein p53 protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:TP53 | GeneID:7157 | Uniprot_SwissProt_Accession:P04637].", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dna content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-p53 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 3, + "assayName": "APR_HepG2_24hr", + "assayDesc": "APR_HepG2_24hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 329, + "geneName": "tumor protein p53", + "description": null, + "geneSymbol": "TP53", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7157, + "officialSymbol": "TP53", + "officialFullName": "tumor protein p53", + "uniprotAccessionNumber": "P04637" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 42, + "assayComponentEndpointName": "APR_HepG2_StressKinase_24hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_StressKinase_24hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_StressKinase_24hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of enzyme reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene . \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is stress response.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "stress response", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 21, + "assayComponentName": "APR_HepG2_StressKinase_24hr", + "assayComponentDesc": "APR_HepG2_StressKinase_24hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_24hr assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "anti-phospho-c-jun antibody is used to tag and quantify the level of phosphorylated jun proto-oncogene protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:JUN | GeneID:3725 | Uniprot_SwissProt_Accession:P05412].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "oxidative phosphorylation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-phospho-c-jun antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 3, + "assayName": "APR_HepG2_24hr", + "assayDesc": "APR_HepG2_24hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 183, + "geneName": "jun proto-oncogene", + "description": null, + "geneSymbol": "JUN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3725, + "officialSymbol": "JUN", + "officialFullName": "jun proto-oncogene", + "uniprotAccessionNumber": "P05412" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 44, + "assayComponentEndpointName": "APR_HepG2_CellCycleArrest_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_CellCycleArrest_72hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_CellCycleArrest_72hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, measures of all nuclear dna for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene . \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is arrest.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "arrest", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 22, + "assayComponentName": "APR_HepG2_CellCycleArrest_72hr", + "assayComponentDesc": "APR_HepG2_CellCycleArrest_72hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_72hr assay. It is designed to make measurements of cell phenotype, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Hoechst-33342 dye is used as a stain for DNA to understand morphology in the system.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst-33342 dye", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 4, + "assayName": "APR_HepG2_72hr", + "assayDesc": "APR_HepG2_72hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 72 hours after chemical dosing in a 384-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 46, + "assayComponentEndpointName": "APR_HepG2_CellLoss_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_CellLoss_72hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_CellLoss_72hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of all nuclear dna for gain or loss-of-signal activity can be used to understand the viability at the cellular-level. \nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is proliferation.", + "assayFunctionType": "viability", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin;Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 23, + "assayComponentName": "APR_HepG2_CellLoss_72hr", + "assayComponentDesc": "APR_HepG2_CellLoss_72hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_72hr assay. It is designed to make measurements of cell number, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Hoechst-33342 dye is used as a stain for DNA to understand viability in the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "cell number", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst-33342 dye", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 4, + "assayName": "APR_HepG2_72hr", + "assayDesc": "APR_HepG2_72hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 72 hours after chemical dosing in a 384-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 48, + "assayComponentEndpointName": "APR_HepG2_MicrotubuleCSK_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_MicrotubuleCSK_72hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_MicrotubuleCSK_72hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of conformation reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the cellular-level. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is cell conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 24, + "assayComponentName": "APR_HepG2_MicrotubuleCSK_72hr", + "assayComponentDesc": "APR_HepG2_MicrotubuleCSK_72hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_72hr assay. It is designed to make measurements of protein conformation, a form of conformation reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "anti-a-tubulin antibody is used to tag and quantify the level of tubulin, alpha 1a protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:TUBA1A | GeneID:7846 | Uniprot_SwissProt_Accession:Q71U36].", + "parameterReadoutType": "single", + "assayDesignType": "conformation reporter", + "assayDesignTypeSub": "protein conformation", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-a-tubulin antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 4, + "assayName": "APR_HepG2_72hr", + "assayDesc": "APR_HepG2_72hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 72 hours after chemical dosing in a 384-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 339, + "geneName": "tubulin, alpha 1a", + "description": null, + "geneSymbol": "TUBA1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7846, + "officialSymbol": "TUBA1A", + "officialFullName": "tubulin, alpha 1a", + "uniprotAccessionNumber": "Q71U36" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 551, + "assayComponentEndpointName": "NVS_ENZ_hPTPRF", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPRF was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPRF, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPRF. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 317, + "assayComponentName": "NVS_ENZ_hPTPRF", + "assayComponentDesc": "NVS_ENZ_hPTPRF is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPRF assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein tyrosine phosphatase, receptor type, F [GeneSymbol:PTPRF | GeneID:5792 | Uniprot_SwissProt_Accession:P10586].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 131, + "assayName": "NVS_ENZ_hPTPRF", + "assayDesc": "NVS_ENZ_hPTPRF is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 276, + "geneName": "protein tyrosine phosphatase, receptor type, F", + "description": null, + "geneSymbol": "PTPRF", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5792, + "officialSymbol": "PTPRF", + "officialFullName": "protein tyrosine phosphatase, receptor type, F", + "uniprotAccessionNumber": "P10586" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1943774", + "pmid": 1943774, + "title": "Use of vanadate as protein-phosphotyrosine phosphatase inhibitor", + "author": "Gordon JA", + "citation": "Gordon JA. Use of vanadate as protein-phosphotyrosine phosphatase inhibitor. Methods Enzymol. 1991;201:477-82. Review. PubMed PMID: 1943774.", + "otherId": "0", + "citationId": 26, + "otherSource": "" + } + }, + { + "aeid": 553, + "assayComponentEndpointName": "NVS_ENZ_hPTPRM", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPTPRM was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPTPRM, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTPRM. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is receptor tyrosine phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "receptor tyrosine phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 318, + "assayComponentName": "NVS_ENZ_hPTPRM", + "assayComponentDesc": "NVS_ENZ_hPTPRM is one of one assay component(s) measured or calculated from the NVS_ENZ_hPTPRM assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human protein tyrosine phosphatase, receptor type, M [GeneSymbol:PTPRM | GeneID:5797 | Uniprot_SwissProt_Accession:P28827].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 132, + "assayName": "NVS_ENZ_hPTPRM", + "assayDesc": "NVS_ENZ_hPTPRM is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1.33 hours after chemical dosing in a 384-well plate.", + "timepointHr": 1.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 277, + "geneName": "protein tyrosine phosphatase, receptor type, M", + "description": null, + "geneSymbol": "PTPRM", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5797, + "officialSymbol": "PTPRM", + "officialFullName": "protein tyrosine phosphatase, receptor type, M", + "uniprotAccessionNumber": "P28827" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 555, + "assayComponentEndpointName": "NVS_ENZ_hRAF1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hRAF1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hRAF1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene RAF1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "SB203580", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 319, + "assayComponentName": "NVS_ENZ_hRAF1", + "assayComponentDesc": "NVS_ENZ_hRAF1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hRAF1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human Raf-1 proto-oncogene, serine/threonine kinase [GeneSymbol:RAF1 | GeneID:5894 | Uniprot_SwissProt_Accession:P04049].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 133, + "assayName": "NVS_ENZ_hRAF1", + "assayDesc": "NVS_ENZ_hRAF1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 278, + "geneName": "Raf-1 proto-oncogene, serine/threonine kinase", + "description": null, + "geneSymbol": "RAF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5894, + "officialSymbol": "RAF1", + "officialFullName": "Raf-1 proto-oncogene, serine/threonine kinase", + "uniprotAccessionNumber": "P04049" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 557, + "assayComponentEndpointName": "NVS_ENZ_hROCK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hROCK1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hROCK1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene ROCK1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 320, + "assayComponentName": "NVS_ENZ_hROCK1", + "assayComponentDesc": "NVS_ENZ_hROCK1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hROCK1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human Rho-associated, coiled-coil containing protein kinase 1 [GeneSymbol:ROCK1 | GeneID:6093 | Uniprot_SwissProt_Accession:Q13464].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 134, + "assayName": "NVS_ENZ_hROCK1", + "assayDesc": "NVS_ENZ_hROCK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 283, + "geneName": "Rho-associated, coiled-coil containing protein kinase 1", + "description": null, + "geneSymbol": "ROCK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6093, + "officialSymbol": "ROCK1", + "officialFullName": "Rho-associated, coiled-coil containing protein kinase 1", + "uniprotAccessionNumber": "Q13464" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 559, + "assayComponentEndpointName": "NVS_ENZ_hSGK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hSGK1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hSGK1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene SGK1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 321, + "assayComponentName": "NVS_ENZ_hSGK1", + "assayComponentDesc": "NVS_ENZ_hSGK1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hSGK1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human serum/glucocorticoid regulated kinase 1 [GeneSymbol:SGK1 | GeneID:6446 | Uniprot_SwissProt_Accession:O00141].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 135, + "assayName": "NVS_ENZ_hSGK1", + "assayDesc": "NVS_ENZ_hSGK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 295, + "geneName": "serum/glucocorticoid regulated kinase 1", + "description": null, + "geneSymbol": "SGK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6446, + "officialSymbol": "SGK1", + "officialFullName": "serum/glucocorticoid regulated kinase 1", + "uniprotAccessionNumber": "O00141" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 561, + "assayComponentEndpointName": "NVS_ENZ_hSIRT1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hSIRT1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hSIRT1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene SIRT1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the hydrolase intended target family, where the subfamily is protein deacetylase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Suramin;Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "hydrolase", + "intendedTargetFamilySub": "protein deacetylase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 322, + "assayComponentName": "NVS_ENZ_hSIRT1", + "assayComponentDesc": "NVS_ENZ_hSIRT1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hSIRT1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein - Acetylated peptide substrate --> Deacetylated peptide product] involving the key substrate [Fluorescein-labeled acetylated-peptide] are indicative of changes in enzyme function and kinetics for the human sirtuin 1 [GeneSymbol:SIRT1 | GeneID:23411 | Uniprot_SwissProt_Accession:Q96EB6].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled acetylated-peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 136, + "assayName": "NVS_ENZ_hSIRT1", + "assayDesc": "NVS_ENZ_hSIRT1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 377, + "geneName": "sirtuin 1", + "description": null, + "geneSymbol": "SIRT1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 23411, + "officialSymbol": "SIRT1", + "officialFullName": "sirtuin 1", + "uniprotAccessionNumber": "Q96EB6" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 563, + "assayComponentEndpointName": "NVS_ENZ_hSIRT2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hSIRT2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hSIRT2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene SIRT2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the hydrolase intended target family, where the subfamily is protein deacetylase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Suramin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "hydrolase", + "intendedTargetFamilySub": "protein deacetylase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 323, + "assayComponentName": "NVS_ENZ_hSIRT2", + "assayComponentDesc": "NVS_ENZ_hSIRT2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hSIRT2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein - Acetylated peptide substrate --> Deacetylated peptide product] involving the key substrate [Fluorescein-labeled acetylated-peptide] are indicative of changes in enzyme function and kinetics for the human sirtuin 2 [GeneSymbol:SIRT2 | GeneID:22933 | Uniprot_SwissProt_Accession:Q8IXJ6].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled acetylated-peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 137, + "assayName": "NVS_ENZ_hSIRT2", + "assayDesc": "NVS_ENZ_hSIRT2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 374, + "geneName": "sirtuin 2", + "description": null, + "geneSymbol": "SIRT2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 22933, + "officialSymbol": "SIRT2", + "officialFullName": "sirtuin 2", + "uniprotAccessionNumber": "Q8IXJ6" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 565, + "assayComponentEndpointName": "NVS_ENZ_hSIRT3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hSIRT3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hSIRT3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene SIRT3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the hydrolase intended target family, where the subfamily is protein deacetylase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Nicotinamide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "hydrolase", + "intendedTargetFamilySub": "protein deacetylase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 324, + "assayComponentName": "NVS_ENZ_hSIRT3", + "assayComponentDesc": "NVS_ENZ_hSIRT3 is one of one assay component(s) measured or calculated from the NVS_ENZ_hSIRT3 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein - Acetylated peptide substrate --> Deacetylated peptide product] involving the key substrate [Fluorescein-labeled acetylated-peptide] are indicative of changes in enzyme function and kinetics for the human sirtuin 3 [GeneSymbol:SIRT3 | GeneID:23410 | Uniprot_SwissProt_Accession:Q9NTG7].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled acetylated-peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 138, + "assayName": "NVS_ENZ_hSIRT3", + "assayDesc": "NVS_ENZ_hSIRT3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 376, + "geneName": "sirtuin 3", + "description": null, + "geneSymbol": "SIRT3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 23410, + "officialSymbol": "SIRT3", + "officialFullName": "sirtuin 3", + "uniprotAccessionNumber": "Q9NTG7" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 567, + "assayComponentEndpointName": "NVS_ENZ_hSRC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hSRC was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hSRC, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene SRC. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 325, + "assayComponentName": "NVS_ENZ_hSRC", + "assayComponentDesc": "NVS_ENZ_hSRC is one of one assay component(s) measured or calculated from the NVS_ENZ_hSRC assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human SRC proto-oncogene, non-receptor tyrosine kinase [GeneSymbol:SRC | GeneID:6714 | Uniprot_SwissProt_Accession:P12931].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 139, + "assayName": "NVS_ENZ_hSRC", + "assayDesc": "NVS_ENZ_hSRC is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 303, + "geneName": "SRC proto-oncogene, non-receptor tyrosine kinase", + "description": null, + "geneSymbol": "SRC", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6714, + "officialSymbol": "SRC", + "officialFullName": "SRC proto-oncogene, non-receptor tyrosine kinase", + "uniprotAccessionNumber": "P12931" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 569, + "assayComponentEndpointName": "NVS_ENZ_hSyk", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hSyk was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hSyk, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene SYK. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 326, + "assayComponentName": "NVS_ENZ_hSyk", + "assayComponentDesc": "NVS_ENZ_hSyk is one of one assay component(s) measured or calculated from the NVS_ENZ_hSyk assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human spleen tyrosine kinase [GeneSymbol:SYK | GeneID:6850 | Uniprot_SwissProt_Accession:P43405].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 140, + "assayName": "NVS_ENZ_hSyk", + "assayDesc": "NVS_ENZ_hSyk is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 308, + "geneName": "spleen tyrosine kinase", + "description": null, + "geneSymbol": "SYK", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6850, + "officialSymbol": "SYK", + "officialFullName": "spleen tyrosine kinase", + "uniprotAccessionNumber": "P43405" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 571, + "assayComponentEndpointName": "NVS_ENZ_hTie2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hTie2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hTie2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene TEK. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 327, + "assayComponentName": "NVS_ENZ_hTie2", + "assayComponentDesc": "NVS_ENZ_hTie2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hTie2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human TEK tyrosine kinase, endothelial [GeneSymbol:TEK | GeneID:7010 | Uniprot_SwissProt_Accession:Q02763].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 141, + "assayName": "NVS_ENZ_hTie2", + "assayDesc": "NVS_ENZ_hTie2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 313, + "geneName": "TEK tyrosine kinase, endothelial", + "description": null, + "geneSymbol": "TEK", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7010, + "officialSymbol": "TEK", + "officialFullName": "TEK tyrosine kinase, endothelial", + "uniprotAccessionNumber": "Q02763" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 573, + "assayComponentEndpointName": "NVS_ENZ_hTrkA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hTrkA was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hTrkA, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene NTRK1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 328, + "assayComponentName": "NVS_ENZ_hTrkA", + "assayComponentDesc": "NVS_ENZ_hTrkA is one of one assay component(s) measured or calculated from the NVS_ENZ_hTrkA assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human neurotrophic tyrosine kinase, receptor, type 1 [GeneSymbol:NTRK1 | GeneID:4914 | Uniprot_SwissProt_Accession:P04629].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 142, + "assayName": "NVS_ENZ_hTrkA", + "assayDesc": "NVS_ENZ_hTrkA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 222, + "geneName": "neurotrophic tyrosine kinase, receptor, type 1", + "description": null, + "geneSymbol": "NTRK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4914, + "officialSymbol": "NTRK1", + "officialFullName": "neurotrophic tyrosine kinase, receptor, type 1", + "uniprotAccessionNumber": "P04629" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 575, + "assayComponentEndpointName": "NVS_ENZ_hVEGFR1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hVEGFR1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hVEGFR1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene FLT1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 329, + "assayComponentName": "NVS_ENZ_hVEGFR1", + "assayComponentDesc": "NVS_ENZ_hVEGFR1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hVEGFR1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human fms-related tyrosine kinase 1 [GeneSymbol:FLT1 | GeneID:2321 | Uniprot_SwissProt_Accession:P17948].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 143, + "assayName": "NVS_ENZ_hVEGFR1", + "assayDesc": "NVS_ENZ_hVEGFR1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 131, + "geneName": "fms-related tyrosine kinase 1", + "description": null, + "geneSymbol": "FLT1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2321, + "officialSymbol": "FLT1", + "officialFullName": "fms-related tyrosine kinase 1", + "uniprotAccessionNumber": "P17948" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 577, + "assayComponentEndpointName": "NVS_ENZ_hVEGFR2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hVEGFR2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hVEGFR2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene KDR. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 330, + "assayComponentName": "NVS_ENZ_hVEGFR2", + "assayComponentDesc": "NVS_ENZ_hVEGFR2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hVEGFR2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human kinase insert domain receptor (a type III receptor tyrosine kinase) [GeneSymbol:KDR | GeneID:3791 | Uniprot_SwissProt_Accession:P35968].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 144, + "assayName": "NVS_ENZ_hVEGFR2", + "assayDesc": "NVS_ENZ_hVEGFR2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 186, + "geneName": "kinase insert domain receptor (a type III receptor tyrosine kinase)", + "description": null, + "geneSymbol": "KDR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3791, + "officialSymbol": "KDR", + "officialFullName": "kinase insert domain receptor (a type III receptor tyrosine kinase)", + "uniprotAccessionNumber": "P35968" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 579, + "assayComponentEndpointName": "NVS_ENZ_hVEGFR3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hVEGFR3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hVEGFR3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene FLT4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 331, + "assayComponentName": "NVS_ENZ_hVEGFR3", + "assayComponentDesc": "NVS_ENZ_hVEGFR3 is one of one assay component(s) measured or calculated from the NVS_ENZ_hVEGFR3 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human fms-related tyrosine kinase 4 [GeneSymbol:FLT4 | GeneID:2324 | Uniprot_SwissProt_Accession:P35916].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 145, + "assayName": "NVS_ENZ_hVEGFR3", + "assayDesc": "NVS_ENZ_hVEGFR3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 132, + "geneName": "fms-related tyrosine kinase 4", + "description": null, + "geneSymbol": "FLT4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2324, + "officialSymbol": "FLT4", + "officialFullName": "fms-related tyrosine kinase 4", + "uniprotAccessionNumber": "P35916" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 581, + "assayComponentEndpointName": "NVS_ENZ_hZAP70", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hZAP70 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hZAP70, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene ZAP70. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 332, + "assayComponentName": "NVS_ENZ_hZAP70", + "assayComponentDesc": "NVS_ENZ_hZAP70 is one of one assay component(s) measured or calculated from the NVS_ENZ_hZAP70 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human zeta-chain (TCR) associated protein kinase 70kDa [GeneSymbol:ZAP70 | GeneID:7535 | Uniprot_SwissProt_Accession:P43403].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 146, + "assayName": "NVS_ENZ_hZAP70", + "assayDesc": "NVS_ENZ_hZAP70 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 338, + "geneName": "zeta-chain (TCR) associated protein kinase 70kDa", + "description": null, + "geneSymbol": "ZAP70", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7535, + "officialSymbol": "ZAP70", + "officialFullName": "zeta-chain (TCR) associated protein kinase 70kDa", + "uniprotAccessionNumber": "P43403" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 583, + "assayComponentEndpointName": "NVS_ENZ_oCOX1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_oCOX1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_oCOX1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTGS1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is cyclooxygenase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "SC-560", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "cyclooxygenase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 333, + "assayComponentName": "NVS_ENZ_oCOX1", + "assayComponentDesc": "NVS_ENZ_oCOX1 is one of one assay component(s) measured or calculated from the NVS_ENZ_oCOX1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by Colorimetric technology.", + "assayComponentTargetDesc": "Changes to absorbance signals are produced from enzymatic reactions [Reaction:Arachidonic acid -->ProstaglandinG2 | Reduced TMPD-->TMPD(oxidized)(color 590nm)] involving the key substrates [arachidonic acid and N,N,N,N-tetramethyl-p-Phenylene diamine (TMPD)]. These indicate changes to the enzyme function for the sheep prostaglandin-endoperoxide synthase 1 (prostaglandin G/H synthase and cyclooxygenase) [GeneSymbol:PTGS1 | GeneID:443551 | Uniprot_SwissProt_Accession:P05979].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Colorimetric", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate;substrate", + "keyAssayReagent": "arachidonic acid;N,N,N,N-tetramethyl-p-Phenylene diamine (TMPD)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 147, + "assayName": "NVS_ENZ_oCOX1", + "assayDesc": "NVS_ENZ_oCOX1 is a biochemical, single-readout assay that uses extracted gene-proteins from Ovine seminal vesicles in a tissue-based cell-free assay. Measurements were taken 0.66 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.66, + "organismId": 9940, + "organism": "sheep", + "tissue": "testis", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Ovine seminal vesicles", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 461, + "geneName": "prostaglandin-endoperoxide synthase 1 (prostaglandin G/H synthase and cyclooxygenase)", + "description": "provisional", + "geneSymbol": "PTGS1", + "organismId": 6, + "trackStatus": "live", + "entrezGeneId": 443551, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P05979" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/9789085", + "pmid": 9789085, + "title": "Pharmacological analysis of cyclooxygenase-1 in inflammation", + "author": "Smith CJ, Zhang Y, Koboldt CM, Muhammad J, Zweifel BS, Shaffer A, Talley JJ, Masferrer JL, Seibert K, Isakson PC", + "citation": "Smith CJ, Zhang Y, Koboldt CM, Muhammad J, Zweifel BS, Shaffer A, Talley JJ, Masferrer JL, Seibert K, Isakson PC. Pharmacological analysis of cyclooxygenase-1 in inflammation. Proc Natl Acad Sci U S A. 1998 Oct 27;95(22):13313-8. PubMed PMID: 9789085; PubMed Central PMCID: PMC23795.", + "otherId": "0", + "citationId": 175, + "otherSource": "" + } + }, + { + "aeid": 585, + "assayComponentEndpointName": "NVS_ENZ_oCOX2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_oCOX2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_oCOX2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PTGS2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is cyclooxygenase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "DuP-697", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "cyclooxygenase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 334, + "assayComponentName": "NVS_ENZ_oCOX2", + "assayComponentDesc": "NVS_ENZ_oCOX2 is one of one assay component(s) measured or calculated from the NVS_ENZ_oCOX2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by Colorimetric technology.", + "assayComponentTargetDesc": "Changes to absorbance signals are produced from enzymatic reactions [Reaction:Arachidonic acid -->ProstaglandinG2 | Reduced TMPD-->TMPD(oxidized)(color 590nm)] involving the key substrates [arachidonic acid and N,N,N,N-tetramethyl-p-Phenylene diamine (TMPD)]. These indicate changes to the enzyme function for the sheep prostaglandin-endoperoxide synthase 2 (prostaglandin G/H synthase and cyclooxygenase) [GeneSymbol:PTGS2 | GeneID:443460 | Uniprot_SwissProt_Accession:P79208].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Colorimetric", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate;substrate", + "keyAssayReagent": "arachidonic acid;N,N,N,N-tetramethyl-p-Phenylene diamine (TMPD)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 148, + "assayName": "NVS_ENZ_oCOX2", + "assayDesc": "NVS_ENZ_oCOX2 is a biochemical, single-readout assay that uses extracted gene-proteins from Ovine placenta in a tissue-based cell-free assay. Measurements were taken 0.66 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.66, + "organismId": 9940, + "organism": "sheep", + "tissue": "uterus", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Ovine placenta", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 460, + "geneName": "prostaglandin-endoperoxide synthase 2 (prostaglandin G/H synthase and cyclooxygenase)", + "description": "provisional", + "geneSymbol": "PTGS2", + "organismId": 6, + "trackStatus": "live", + "entrezGeneId": 443460, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P79208" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/8831731", + "pmid": 8831731, + "title": "Mechanism of selective inhibition of human prostaglandin G/H synthase-1 and -2 in intact cells", + "author": "Kargman S, Wong E, Greig GM, Falgueyret JP, Cromlish W, Ethier D, Yergey JA, Riendeau D, Evans JF, Kennedy B, Tagari P, Francis DA, O'Neill GP", + "citation": "Kargman S, Wong E, Greig GM, Falgueyret JP, Cromlish W, Ethier D, Yergey JA, Riendeau D, Evans JF, Kennedy B, Tagari P, Francis DA, O'Neill GP. Mechanism of selective inhibition of human prostaglandin G/H synthase-1 and -2 in intact cells. Biochem Pharmacol. 1996 Oct 11;52(7):1113-25. PubMed PMID: 8831731.", + "otherId": "0", + "citationId": 167, + "otherSource": "" + } + }, + { + "aeid": 587, + "assayComponentEndpointName": "NVS_ENZ_pMTHFR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_pMTHFR was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_pMTHFR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MTHFR. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is methylenetetrahydrofolate reductase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Sulfasalazine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "methylenetetrahydrofolate reductase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 335, + "assayComponentName": "NVS_ENZ_pMTHFR", + "assayComponentDesc": "NVS_ENZ_pMTHFR is one of one assay component(s) measured or calculated from the NVS_ENZ_pMTHFR assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from an enzymatic reaction [Reaction:5-[14C]-methyltetrahydrofolate + menadione --> H[14C]HO + THF] involving the key substrate [5-[14C]-methyltetrahydrofolate] are indicative of changes in enzyme function and kinetics for the pig methylenetetrahydrofolate reductase (NAD(P)H) [GeneSymbol:MTHFR | GeneID:397180 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "5-[14C]-methyltetrahydrofolate", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 149, + "assayName": "NVS_ENZ_pMTHFR", + "assayDesc": "NVS_ENZ_pMTHFR is a biochemical, single-readout assay that uses extracted gene-proteins from Porcine kidney in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9823, + "organism": "pig", + "tissue": "kidney", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Porcine kidney", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 456, + "geneName": "methylenetetrahydrofolate reductase (NAD(P)H)", + "description": "model", + "geneSymbol": "MTHFR", + "organismId": 5, + "trackStatus": "live", + "entrezGeneId": 397180, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/508720", + "pmid": 508720, + "title": "Inhibition of pig liver methylenetetrahydrofolate reductase by dihydrofolate: some mechanistic and regulatory implications", + "author": "Matthews RG, Haywood BJ", + "citation": "Matthews RG, Haywood BJ. Inhibition of pig liver methylenetetrahydrofolate reductase by dihydrofolate: some mechanistic and regulatory implications. Biochemistry. 1979 Oct 30;18(22):4845-51. PubMed PMID: 508720.", + "otherId": "0", + "citationId": 10, + "otherSource": "" + } + }, + { + "aeid": 589, + "assayComponentEndpointName": "NVS_ENZ_rabI2C", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_rabI2C was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_rabI2C, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CKB. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is imidazoline receptor.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "2-BFI", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "imidazoline receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 336, + "assayComponentName": "NVS_ENZ_rabI2C", + "assayComponentDesc": "NVS_ENZ_rabI2C is one of one assay component(s) measured or calculated from the NVS_ENZ_rabI2C assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-2-BFI] are indicative of a change in enzyme function and kinetics for the rabbit creatine kinase, brain [GeneSymbol:CKB | GeneID:100009085 | Uniprot_SwissProt_Accession:P00567].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-2-BFI", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 150, + "assayName": "NVS_ENZ_rabI2C", + "assayDesc": "NVS_ENZ_rabI2C is a biochemical, single-readout assay that uses extracted gene-proteins from Rabbit brain membranes in a tissue-based cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 48-well plate.", + "timepointHr": 1.5, + "organismId": 9986, + "organism": "rabbit", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rabbit brain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 467, + "geneName": "creatine kinase, brain", + "description": "provisional", + "geneSymbol": "CKB", + "organismId": 9, + "trackStatus": "live", + "entrezGeneId": 100009085, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P00567" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1972896", + "pmid": 1972896, + "title": "Alpha 2-adrenoceptor subtypes and imidazoline-like binding sites in the rat brain", + "author": "Brown CM, MacKinnon AC, McGrath JC, Spedding M, Kilpatrick AT", + "citation": "Brown CM, MacKinnon AC, McGrath JC, Spedding M, Kilpatrick AT. Alpha 2-adrenoceptor subtypes and imidazoline-like binding sites in the rat brain. Br J Pharmacol. 1990 Apr;99(4):803-9. PubMed PMID: 1972896; PubMed Central PMCID: PMC1917565.", + "otherId": "0", + "citationId": 27, + "otherSource": "" + } + }, + { + "aeid": 591, + "assayComponentEndpointName": "NVS_ENZ_rACFSKBinding", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_rACFSKBinding was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_rACFSKBinding, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Adcy5. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the lyase intended target family, where the subfamily is adenylyl cyclase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Forskolin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "lyase", + "intendedTargetFamilySub": "adenylyl cyclase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 337, + "assayComponentName": "NVS_ENZ_rACFSKBinding", + "assayComponentDesc": "NVS_ENZ_rACFSKBinding is one of one assay component(s) measured or calculated from the NVS_ENZ_rACFSKBinding assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-forskolin] are indicative of a change in enzyme function and kinetics for the Norway rat adenylate cyclase 5 [GeneSymbol:Adcy5 | GeneID:64532 | Uniprot_SwissProt_Accession:Q04400].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-forskolin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 151, + "assayName": "NVS_ENZ_rACFSKBinding", + "assayDesc": "NVS_ENZ_rACFSKBinding is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 433, + "geneName": "adenylate cyclase 5", + "description": null, + "geneSymbol": "Adcy5", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 64532, + "officialSymbol": "Adcy5", + "officialFullName": "adenylate cyclase 5", + "uniprotAccessionNumber": "Q04400" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/3159185", + "pmid": 3159185, + "title": "High-affinity binding of forskolin to rat brain membranes", + "author": "Seamon KB, Daly JW", + "citation": "Seamon KB, Daly JW. High-affinity binding of forskolin to rat brain membranes. Adv Cyclic Nucleotide Protein Phosphorylation Res. 1985;19:125-35. PubMed PMID: 3159185.", + "otherId": "0", + "citationId": 97, + "otherSource": "" + } + }, + { + "aeid": 593, + "assayComponentEndpointName": "NVS_ENZ_rAChE", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_rAChE was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_rAChE, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Ache. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is acetylcholinesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Physostigmine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "acetylcholinesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 338, + "assayComponentName": "NVS_ENZ_rAChE", + "assayComponentDesc": "NVS_ENZ_rAChE is one of one assay component(s) measured or calculated from the NVS_ENZ_rAChE assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by Colorimetric technology.", + "assayComponentTargetDesc": "Changes to absorbance signals are produced from enzymatic reactions [Reaction:Acetylthiocholine-->Acetate +Thiocholine | Thiocholine + DTNB (Ellman\"s Reagent)--> 5-thio-2-nitrobenzoic acid (yellow)] involving the key substrates [acetylthiocholine and Ellman\"s reagent (DTNB)]. These indicate changes to the enzyme function for the Norway rat acetylcholinesterase [GeneSymbol:Ache | GeneID:83817 | Uniprot_SwissProt_Accession:P37136].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Colorimetric", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate;substrate", + "keyAssayReagent": "acetylthiocholine;Ellman\"s reagent (DTNB)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 152, + "assayName": "NVS_ENZ_rAChE", + "assayDesc": "NVS_ENZ_rAChE is a biochemical, single-readout assay that uses extracted gene-proteins from Rat brain membranes in a tissue-based cell-free assay. Measurements were taken 0.33 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.33, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat brain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 441, + "geneName": "acetylcholinesterase", + "description": "provisional", + "geneSymbol": "Ache", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 83817, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P37136" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/13726518", + "pmid": 13726518, + "title": "A new and rapid colorimetric determination of acetylcholinesterase activity", + "author": "ELLMAN GL, COURTNEY KD, ANDRES V Jr, FEATHER-STONE RM", + "citation": "ELLMAN GL, COURTNEY KD, ANDRES V Jr, FEATHER-STONE RM. A new and rapid colorimetric determination of acetylcholinesterase activity. Biochem Pharmacol. 1961 Jul;7:88-95. PubMed PMID: 13726518.", + "otherId": "0", + "citationId": 197, + "otherSource": "" + } + }, + { + "aeid": 595, + "assayComponentEndpointName": "NVS_ENZ_rCNOS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_rCNOS was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_rCNOS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Nos1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is nitric oxide synthase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Nitro-L-Arginine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "nitric oxide synthase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 339, + "assayComponentName": "NVS_ENZ_rCNOS", + "assayComponentDesc": "NVS_ENZ_rCNOS is one of one assay component(s) measured or calculated from the NVS_ENZ_rCNOS assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Nitro-L-Arginine] are indicative of a change in enzyme function and kinetics for the Norway rat nitric oxide synthase 1, neuronal [GeneSymbol:Nos1 | GeneID:24598 | Uniprot_SwissProt_Accession:P29476].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Nitro-L-Arginine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 153, + "assayName": "NVS_ENZ_rCNOS", + "assayDesc": "NVS_ENZ_rCNOS is a biochemical, single-readout assay that uses extracted gene-proteins from Rat brain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat brain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 392, + "geneName": "nitric oxide synthase 1, neuronal", + "description": null, + "geneSymbol": "Nos1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24598, + "officialSymbol": "Nos1", + "officialFullName": "nitric oxide synthase 1, neuronal", + "uniprotAccessionNumber": "P29476" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7689392", + "pmid": 7689392, + "title": "Characterization of the binding of [3H]-L-NG-nitro-arginine in rat brain", + "author": "Michel AD, Phul RK, Stewart TL, Humphrey PP", + "citation": "Michel AD, Phul RK, Stewart TL, Humphrey PP. Characterization of the binding of [3H]-L-NG-nitro-arginine in rat brain. Br J Pharmacol. 1993 Jun;109(2):287-8. PubMed PMID: 7689392; PubMed Central PMCID: PMC2175700.", + "otherId": "0", + "citationId": 144, + "otherSource": "" + } + }, + { + "aeid": 597, + "assayComponentEndpointName": "NVS_ENZ_rCOMT", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_rCOMT was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_rCOMT, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Comt. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the methyltransferase intended target family, where the subfamily is o-methyltransferase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "OR-486", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "methyltransferase", + "intendedTargetFamilySub": "o-methyltransferase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 340, + "assayComponentName": "NVS_ENZ_rCOMT", + "assayComponentDesc": "NVS_ENZ_rCOMT is one of one assay component(s) measured or calculated from the NVS_ENZ_rCOMT assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by HPLC and Spectrophotometry technology.", + "assayComponentTargetDesc": "Changes to absorbance signals produced from an enzymatic reaction involving the key substrate [3,4-dihydroxybenzoid acid] are indicative of changes in enzyme function and kinetics for the Norway rat catechol-O-methyltransferase [GeneSymbol:Comt | GeneID:24267 | Uniprot_SwissProt_Accession:P22734].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "HPLC and Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "3,4-dihydroxybenzoid acid", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 154, + "assayName": "NVS_ENZ_rCOMT", + "assayDesc": "NVS_ENZ_rCOMT is a biochemical, single-readout assay that uses extracted gene-proteins from Rat dorsal striatum in a tissue-based cell-free assay. Measurements were taken 0 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat dorsal striatum", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 383, + "geneName": "catechol-O-methyltransferase", + "description": null, + "geneSymbol": "Comt", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24267, + "officialSymbol": "Comt", + "officialFullName": "catechol-O-methyltransferase", + "uniprotAccessionNumber": "P22734" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2291472", + "pmid": 2291472, + "title": "Determination of catechol O-methyltransferase activity in relation to melanin metabolism using high-performance liquid chromatography with fluorimetric detection", + "author": "Smit NP, Pavel S, Kammeyer A, Westerhof W", + "citation": "Smit NP, Pavel S, Kammeyer A, Westerhof W. Determination of catechol O-methyltransferase activity in relation to melanin metabolism using high-performance liquid chromatography with fluorimetric detection. Anal Biochem. 1990 Nov 1;190(2):286-91. PubMed PMID: 2291472.", + "otherId": "0", + "citationId": 42, + "otherSource": "" + } + }, + { + "aeid": 599, + "assayComponentEndpointName": "NVS_ENZ_hDYRK1a", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hDYRK1a was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hDYRK1a, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene DYRK1A. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is dual-specific kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "dual-specific kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 341, + "assayComponentName": "NVS_ENZ_hDYRK1a", + "assayComponentDesc": "NVS_ENZ_hDYRK1a is one of one assay component(s) measured or calculated from the NVS_ENZ_hDYRK1a assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human dual-specificity tyrosine-(Y)-phosphorylation regulated kinase 1A [GeneSymbol:DYRK1A | GeneID:1859 | Uniprot_SwissProt_Accession:Q13627].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 155, + "assayName": "NVS_ENZ_hDYRK1a", + "assayDesc": "NVS_ENZ_hDYRK1a is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 103, + "geneName": "dual-specificity tyrosine-(Y)-phosphorylation regulated kinase 1A", + "description": null, + "geneSymbol": "DYRK1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1859, + "officialSymbol": "DYRK1A", + "officialFullName": "dual-specificity tyrosine-(Y)-phosphorylation regulated kinase 1A", + "uniprotAccessionNumber": "Q13627" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 601, + "assayComponentEndpointName": "NVS_ENZ_rMAOAC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_rMAOAC was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_rMAOAC, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Maoa. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is monoamine oxidase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ro 41-1049;Tetrindole mesylate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "monoamine oxidase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 342, + "assayComponentName": "NVS_ENZ_rMAOAC", + "assayComponentDesc": "NVS_ENZ_rMAOAC is one of one assay component(s) measured or calculated from the NVS_ENZ_rMAOAC assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from an enzymatic reaction [Reaction:[14C]-Serotonin --> [14C]-5-hydroxyindoleacetaldehyde(HIA)] involving the key substrate [[14C]-Serotonin (5HT)] are indicative of changes in enzyme function and kinetics for the Norway rat monoamine oxidase A [GeneSymbol:Maoa | GeneID:29253 | Uniprot_SwissProt_Accession:P21396].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "[14C]-Serotonin (5HT)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 156, + "assayName": "NVS_ENZ_rMAOAC", + "assayDesc": "NVS_ENZ_rMAOAC is a biochemical, single-readout assay that uses extracted gene-proteins from Rat brain in a tissue-based cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 96-well plate.", + "timepointHr": 1.5, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat brain", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 417, + "geneName": "monoamine oxidase A", + "description": null, + "geneSymbol": "Maoa", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 29253, + "officialSymbol": "Maoa", + "officialFullName": "monoamine oxidase A", + "uniprotAccessionNumber": "P21396" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/14201142", + "pmid": 14201142, + "title": "RADIOISOTOPIC ASSAY FOR MONOAMINE OXIDASE\nDETERMINATIONS IN HUMAN PLASMA", + "author": "OTSUKA S, KOBAYASHI Y", + "citation": "OTSUKA S, KOBAYASHI Y. RADIOISOTOPIC ASSAY FOR MONOAMINE OXIDASE\nDETERMINATIONS IN HUMAN PLASMA. Biochem Pharmacol. 1964 Jul;13:995-1006. PubMed\nPMID: 14201142.", + "otherId": "0", + "citationId": 198, + "otherSource": "" + } + }, + { + "aeid": 603, + "assayComponentEndpointName": "NVS_ENZ_rMAOAP", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_rMAOAP was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_rMAOAP, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Maoa. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is monoamine oxidase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ro 41-1049;Tetrindole mesylate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "monoamine oxidase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 343, + "assayComponentName": "NVS_ENZ_rMAOAP", + "assayComponentDesc": "NVS_ENZ_rMAOAP is one of one assay component(s) measured or calculated from the NVS_ENZ_rMAOAP assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from an enzymatic reaction [Reaction:[14C]-Serotonin --> [14C]-5-hydroxyindoleacetaldehyde(HIA)] involving the key substrate [[14C]-Serotonin (5HT)] are indicative of changes in enzyme function and kinetics for the Norway rat monoamine oxidase A [GeneSymbol:Maoa | GeneID:29253 | Uniprot_SwissProt_Accession:P21396].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "[14C]-Serotonin (5HT)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 157, + "assayName": "NVS_ENZ_rMAOAP", + "assayDesc": "NVS_ENZ_rMAOAP is a biochemical, single-readout assay that uses extracted gene-proteins from Rat liver mitochondrial membranes in a tissue-based cell-free assay. Measurements were taken 1.17 hours after chemical dosing in a 96-well plate.", + "timepointHr": 1.17, + "organismId": 10116, + "organism": "rat", + "tissue": "liver", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat liver mitochondrial membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 417, + "geneName": "monoamine oxidase A", + "description": null, + "geneSymbol": "Maoa", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 29253, + "officialSymbol": "Maoa", + "officialFullName": "monoamine oxidase A", + "uniprotAccessionNumber": "P21396" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/14201142", + "pmid": 14201142, + "title": "RADIOISOTOPIC ASSAY FOR MONOAMINE OXIDASE\nDETERMINATIONS IN HUMAN PLASMA", + "author": "OTSUKA S, KOBAYASHI Y", + "citation": "OTSUKA S, KOBAYASHI Y. RADIOISOTOPIC ASSAY FOR MONOAMINE OXIDASE\nDETERMINATIONS IN HUMAN PLASMA. Biochem Pharmacol. 1964 Jul;13:995-1006. PubMed\nPMID: 14201142.", + "otherId": "0", + "citationId": 198, + "otherSource": "" + } + }, + { + "aeid": 605, + "assayComponentEndpointName": "NVS_ENZ_rMAOBC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_rMAOBC was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_rMAOBC, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Maob. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is monoamine oxidase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ro 16-6491", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "monoamine oxidase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 344, + "assayComponentName": "NVS_ENZ_rMAOBC", + "assayComponentDesc": "NVS_ENZ_rMAOBC is one of one assay component(s) measured or calculated from the NVS_ENZ_rMAOBC assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from an enzymatic reaction [Reaction:[14C]-Phenylethylamine --> [14C]-Phenylacetaldehyde] involving the key substrate [[14C]-Phenylethylamine (PEA)] are indicative of changes in enzyme function and kinetics for the Norway rat monoamine oxidase B [GeneSymbol:Maob | GeneID:25750 | Uniprot_SwissProt_Accession:P19643].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "[14C]-Phenylethylamine (PEA)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 158, + "assayName": "NVS_ENZ_rMAOBC", + "assayDesc": "NVS_ENZ_rMAOBC is a biochemical, single-readout assay that uses extracted gene-proteins from Rat brain in a tissue-based cell-free assay. Measurements were taken 1.17 hours after chemical dosing in a 96-well plate.", + "timepointHr": 1.17, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat brain", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 415, + "geneName": "monoamine oxidase B", + "description": null, + "geneSymbol": "Maob", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25750, + "officialSymbol": "Maob", + "officialFullName": "monoamine oxidase B", + "uniprotAccessionNumber": "P19643" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/14201142", + "pmid": 14201142, + "title": "RADIOISOTOPIC ASSAY FOR MONOAMINE OXIDASE\nDETERMINATIONS IN HUMAN PLASMA", + "author": "OTSUKA S, KOBAYASHI Y", + "citation": "OTSUKA S, KOBAYASHI Y. RADIOISOTOPIC ASSAY FOR MONOAMINE OXIDASE\nDETERMINATIONS IN HUMAN PLASMA. Biochem Pharmacol. 1964 Jul;13:995-1006. PubMed\nPMID: 14201142.", + "otherId": "0", + "citationId": 198, + "otherSource": "" + } + }, + { + "aeid": 607, + "assayComponentEndpointName": "NVS_ENZ_rMAOBP", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_rMAOBP was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_rMAOBP, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Maob. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is monoamine oxidase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ro 16-6491", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "monoamine oxidase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 345, + "assayComponentName": "NVS_ENZ_rMAOBP", + "assayComponentDesc": "NVS_ENZ_rMAOBP is one of one assay component(s) measured or calculated from the NVS_ENZ_rMAOBP assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from an enzymatic reaction [Reaction:[14C]-Phenylethylamine --> [14C]-Phenylacetaldehyde] involving the key substrate [[14C]-Phenylethylamine (PEA)] are indicative of changes in enzyme function and kinetics for the Norway rat monoamine oxidase B [GeneSymbol:Maob | GeneID:25750 | Uniprot_SwissProt_Accession:P19643].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "[14C]-Phenylethylamine (PEA)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 159, + "assayName": "NVS_ENZ_rMAOBP", + "assayDesc": "NVS_ENZ_rMAOBP is a biochemical, single-readout assay that uses extracted gene-proteins from Rat brain in a tissue-based cell-free assay. Measurements were taken 1.17 hours after chemical dosing in a 96-well plate.", + "timepointHr": 1.17, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat brain", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 415, + "geneName": "monoamine oxidase B", + "description": null, + "geneSymbol": "Maob", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25750, + "officialSymbol": "Maob", + "officialFullName": "monoamine oxidase B", + "uniprotAccessionNumber": "P19643" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/14201142", + "pmid": 14201142, + "title": "RADIOISOTOPIC ASSAY FOR MONOAMINE OXIDASE\nDETERMINATIONS IN HUMAN PLASMA", + "author": "OTSUKA S, KOBAYASHI Y", + "citation": "OTSUKA S, KOBAYASHI Y. RADIOISOTOPIC ASSAY FOR MONOAMINE OXIDASE\nDETERMINATIONS IN HUMAN PLASMA. Biochem Pharmacol. 1964 Jul;13:995-1006. PubMed\nPMID: 14201142.", + "otherId": "0", + "citationId": 198, + "otherSource": "" + } + }, + { + "aeid": 609, + "assayComponentEndpointName": "NVS_GPCR_bAdoR_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_bAdoR_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_bAdoR_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene ADORA1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "5\"-N-ethylcarboxamidoadenosine (NECA)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 346, + "assayComponentName": "NVS_GPCR_bAdoR_NonSelective", + "assayComponentDesc": "NVS_GPCR_bAdoR_NonSelective is one of one assay component(s) measured or calculated from the NVS_GPCR_bAdoR_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-5\"-N-ethylcarboxamidoadenosine] are indicative of a change in receptor function and kinetics for the cattle adenosine A1 receptor [GeneSymbol:ADORA1 | GeneID:282133 | Uniprot_SwissProt_Accession:P28190].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-5\"-N-ethylcarboxamidoadenosine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 160, + "assayName": "NVS_GPCR_bAdoR_NonSelective", + "assayDesc": "NVS_GPCR_bAdoR_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Bovine striatal membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9913, + "organism": "bovine", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Bovine striatal membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 451, + "geneName": "adenosine A1 receptor", + "description": null, + "geneSymbol": "ADORA1", + "organismId": 4, + "trackStatus": "live", + "entrezGeneId": 282133, + "officialSymbol": "ADORA1", + "officialFullName": "adenosine A1 receptor", + "uniprotAccessionNumber": "P28190" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1846425", + "pmid": 1846425, + "title": "Role of adenosine receptors in caffeine tolerance", + "author": "Holtzman SG, Mante S, Minneman KP", + "citation": "Holtzman SG, Mante S, Minneman KP. Role of adenosine receptors in caffeine tolerance. J Pharmacol Exp Ther. 1991 Jan;256(1):62-8. PubMed PMID: 1846425.", + "otherId": "0", + "citationId": 25, + "otherSource": "" + } + }, + { + "aeid": 610, + "assayComponentEndpointName": "NVS_GPCR_bAT2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_bAT2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_bAT2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene AGTR2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Angiotensin II", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 347, + "assayComponentName": "NVS_GPCR_bAT2", + "assayComponentDesc": "NVS_GPCR_bAT2 is one of one assay component(s) measured or calculated from the NVS_GPCR_bAT2 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Tyr4-Angiotensin II] are indicative of a change in receptor function and kinetics for the cattle angiotensin II receptor, type 2 [GeneSymbol:AGTR2 | GeneID:407157 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Tyr4-Angiotensin II", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 161, + "assayName": "NVS_GPCR_bAT2", + "assayDesc": "NVS_GPCR_bAT2 is a biochemical, single-readout assay that uses extracted gene-proteins from Bovine cerebellar membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9913, + "organism": "bovine", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Bovine cerebellar membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 458, + "geneName": "angiotensin II receptor, type 2", + "description": null, + "geneSymbol": "AGTR2", + "organismId": 4, + "trackStatus": "live", + "entrezGeneId": 407157, + "officialSymbol": "AGTR2", + "officialFullName": "angiotensin II receptor, type 2", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/187587", + "pmid": 187587, + "title": "Angiotensin II binding to mammalian brain membranes", + "author": "Bennett JP Jr, Snyder SH", + "citation": "Bennett JP Jr, Snyder SH. Angiotensin II binding to mammalian brain membranes. J Biol Chem. 1976 Dec 10;251(23):7423-30. PubMed PMID: 187587.", + "otherId": "0", + "citationId": 4, + "otherSource": "" + } + }, + { + "aeid": 611, + "assayComponentEndpointName": "NVS_GPCR_bDR_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_bDR_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_bDR_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene DRD1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Spiperone HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 348, + "assayComponentName": "NVS_GPCR_bDR_NonSelective", + "assayComponentDesc": "NVS_GPCR_bDR_NonSelective is one of one assay component(s) measured or calculated from the NVS_GPCR_bDR_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Spiperone] are indicative of a change in receptor function and kinetics for the cattle dopamine receptor D1 [GeneSymbol:DRD1 | GeneID:281125 | Uniprot_SwissProt_Accession:Q95136].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Spiperone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 162, + "assayName": "NVS_GPCR_bDR_NonSelective", + "assayDesc": "NVS_GPCR_bDR_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Bovine striatal membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 9913, + "organism": "bovine", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Bovine striatal membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 449, + "geneName": "dopamine receptor D1", + "description": null, + "geneSymbol": "DRD1", + "organismId": 4, + "trackStatus": "live", + "entrezGeneId": 281125, + "officialSymbol": "DRD1", + "officialFullName": "dopamine receptor D1", + "uniprotAccessionNumber": "Q95136" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23126", + "pmid": 23126, + "title": "Spiperone: a ligand of choice for neuroleptic receptors. 1. Kinetics and characteristics of in vitro binding", + "author": "Leysen JE, Gommeren W, Laduron PM", + "citation": "Leysen JE, Gommeren W, Laduron PM. Spiperone: a ligand of choice for neuroleptic receptors. 1. Kinetics and characteristics of in vitro binding. Biochem Pharmacol. 1978 Feb 1;27(3):307-16. PubMed PMID: 23126.", + "otherId": "0", + "citationId": 1, + "otherSource": "" + } + }, + { + "aeid": 50, + "assayComponentEndpointName": "APR_HepG2_MitoMass_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_MitoMass_72hr was analyzed into 1 assay endpoint. This assay endpoint, APR_HepG2_MitoMass_72hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is organelle conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "organelle conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 25, + "assayComponentName": "APR_HepG2_MitoMass_72hr", + "assayComponentDesc": "APR_HepG2_MitoMass_72hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_72hr assay. It is designed to make measurements of cell phenotype, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "MitoTracker Red is used as a stain for the morphology of the mitochondria.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "MitoTracker Red", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 4, + "assayName": "APR_HepG2_72hr", + "assayDesc": "APR_HepG2_72hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 72 hours after chemical dosing in a 384-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 52, + "assayComponentEndpointName": "APR_HepG2_MitoMembPot_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_MitoMembPot_72hr was analyzed into 1 assay endpoint. This assay endpoint, APR_HepG2_MitoMembPot_72hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of membrane potential reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is organelle conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "organelle conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 26, + "assayComponentName": "APR_HepG2_MitoMembPot_72hr", + "assayComponentDesc": "APR_HepG2_MitoMembPot_72hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_72hr assay. It is designed to make measurements of dye binding, a form of membrane potential reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "MitoTracker Red is used as a stain for the membrane potential of the mitochondria.", + "parameterReadoutType": "single", + "assayDesignType": "membrane potential reporter", + "assayDesignTypeSub": "dye binding", + "biologicalProcessTarget": "mitochondrial depolarization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "MitoTracker Red", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 4, + "assayName": "APR_HepG2_72hr", + "assayDesc": "APR_HepG2_72hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 72 hours after chemical dosing in a 384-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 54, + "assayComponentEndpointName": "APR_HepG2_MitoticArrest_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_MitoticArrest_72hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_MitoticArrest_72hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene . \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is arrest.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "arrest", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 27, + "assayComponentName": "APR_HepG2_MitoticArrest_72hr", + "assayComponentDesc": "APR_HepG2_MitoticArrest_72hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_72hr assay. It is designed to make measurements of cell phenotype, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "anti-phospho-histone-H3 antibody is used to tag and quantify the level of phosphorylated H3 histone, family 3A protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:H3F3A | GeneID:3020 | Uniprot_SwissProt_Accession:P84243].", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-phospho-histone-H3 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 4, + "assayName": "APR_HepG2_72hr", + "assayDesc": "APR_HepG2_72hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 72 hours after chemical dosing in a 384-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 150, + "geneName": "H3 histone, family 3A", + "description": null, + "geneSymbol": "H3F3A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3020, + "officialSymbol": "H3F3A", + "officialFullName": "H3 histone, family 3A", + "uniprotAccessionNumber": "P84243" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 56, + "assayComponentEndpointName": "APR_HepG2_NuclearSize_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_NuclearSize_72hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_NuclearSize_72hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, measures of all nuclear dna for gain or loss-of-signal activity can be used to understand the signaling at the nuclear-level. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is organelle conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Paclitaxel;CCCP", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "organelle conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 28, + "assayComponentName": "APR_HepG2_NuclearSize_72hr", + "assayComponentDesc": "APR_HepG2_NuclearSize_72hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_72hr assay. It is designed to make measurements of cell phenotype, a form of morphology reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Hoechst-33342 dye is used as a stain for DNA to understand morphology in the system.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell cycle", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Hoechst-33342 dye", + "technologicalTargetType": "dna", + "technologicalTargetTypeSub": "dna-unspecified", + "aid": 4, + "assayName": "APR_HepG2_72hr", + "assayDesc": "APR_HepG2_72hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 72 hours after chemical dosing in a 384-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 58, + "assayComponentEndpointName": "APR_HepG2_P-H2AX_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_P-H2AX_72hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_P-H2AX_72hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene . \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is cellular response to DNA damage stimulus.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "cellular response to DNA damage stimulus", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 29, + "assayComponentName": "APR_HepG2_P-H2AX_72hr", + "assayComponentDesc": "APR_HepG2_P-H2AX_72hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_72hr assay. It is designed to make measurements of dna content, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "Anti-phospho-histone-H2AX antibody is used to tag and quantify the level of phosphorylated H2A histone family, member X protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:H2AFX | GeneID:3014 | Uniprot_SwissProt_Accession:P16104].", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dna content", + "biologicalProcessTarget": "oxidative phosphorylation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-phospho-histone-H2AX antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 4, + "assayName": "APR_HepG2_72hr", + "assayDesc": "APR_HepG2_72hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 72 hours after chemical dosing in a 384-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 149, + "geneName": "H2A histone family, member X", + "description": null, + "geneSymbol": "H2AFX", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3014, + "officialSymbol": "H2AFX", + "officialFullName": "H2A histone family, member X", + "uniprotAccessionNumber": "P16104" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 60, + "assayComponentEndpointName": "APR_HepG2_p53Act_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_p53Act_72hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_p53Act_72hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene TP53. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is tumor suppressor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "tumor suppressor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 30, + "assayComponentName": "APR_HepG2_p53Act_72hr", + "assayComponentDesc": "APR_HepG2_p53Act_72hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_72hr assay. It is designed to make measurements of dna content, a form of viability reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "anti-p53 antibody is used to tag and quantify the level of tumor protein p53 protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:TP53 | GeneID:7157 | Uniprot_SwissProt_Accession:P04637].", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dna content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-p53 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 4, + "assayName": "APR_HepG2_72hr", + "assayDesc": "APR_HepG2_72hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 72 hours after chemical dosing in a 384-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 329, + "geneName": "tumor protein p53", + "description": null, + "geneSymbol": "TP53", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7157, + "officialSymbol": "TP53", + "officialFullName": "tumor protein p53", + "uniprotAccessionNumber": "P04637" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 62, + "assayComponentEndpointName": "APR_HepG2_StressKinase_72hr", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component APR_HepG2_StressKinase_72hr was analyzed into 1 assay endpoint. \nThis assay endpoint, APR_HepG2_StressKinase_72hr, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of enzyme reporter, measures of protein for gain or loss-of-signal activity can be used to understand the signaling at the pathway-level as they relate to the gene . \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is stress response.", + "assayFunctionType": "signaling", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Camptothecin;Anisomycin", + "signalDirection": "bidirectional", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "stress response", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 31, + "assayComponentName": "APR_HepG2_StressKinase_72hr", + "assayComponentDesc": "APR_HepG2_StressKinase_72hr is one of 10 assay component(s) measured or calculated from the APR_HepG2_72hr assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by HCS Fluorescent Imaging technology.", + "assayComponentTargetDesc": "anti-phospho-c-jun antibody is used to tag and quantify the level of phosphorylated jun proto-oncogene protein. Changes in the signals are indicative of protein expression changes as a cellular response to stress in the system [GeneSymbol:JUN | GeneID:3725 | Uniprot_SwissProt_Accession:P05412].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "oxidative phosphorylation", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "anti-phospho-c-jun antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 4, + "assayName": "APR_HepG2_72hr", + "assayDesc": "APR_HepG2_72hr is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 72 hours after chemical dosing in a 384-well plate.", + "timepointHr": 72.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 2, + "assaySourceName": "APR", + "assaySourceLongName": "Apredica", + "assaySourceDesc": "Apredica, a part of Cyprotex, is a preclinical Contract Research Organization (CRO) that provides services including the CellCiphr High Content Imaging system.", + "gene": { + "geneId": 183, + "geneName": "jun proto-oncogene", + "description": null, + "geneSymbol": "JUN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3725, + "officialSymbol": "JUN", + "officialFullName": "jun proto-oncogene", + "uniprotAccessionNumber": "P05412" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057110376413", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/20639501", + "pmid": 20639501, + "title": "Early safety assessment using cellular systems biology yields insights into mechanisms of action", + "author": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA", + "citation": "Giuliano KA, Gough AH, Taylor DL, Vernetti LA, Johnston PA. Early safety assessment using cellular systems biology yields insights into mechanisms of action. J Biomol Screen. 2010 Aug;15(7):783-97. doi: 10.1177/1087057110376413. Epub 2010 Jul 16. PubMed PMID: 20639501.", + "otherId": "0", + "citationId": 225, + "otherSource": "" + } + }, + { + "aeid": 63, + "assayComponentEndpointName": "ATG_Ahr_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_Ahr_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_Ahr_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain or loss-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AHR. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic helix-loop-helix protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "6-formylindolo carbazole", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic helix-loop-helix protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 32, + "assayComponentName": "ATG_Ahr_CIS", + "assayComponentDesc": "ATG_Ahr_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element AhRE, which is responsive to the endogenous human aryl hydrocarbon receptor [GeneSymbol:AHR | GeneID:196 | Uniprot_SwissProt_Accession:P35869].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "AhRE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 21, + "geneName": "aryl hydrocarbon receptor", + "description": null, + "geneSymbol": "AHR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 196, + "officialSymbol": "AHR", + "officialFullName": "aryl hydrocarbon receptor", + "uniprotAccessionNumber": "P35869" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 64, + "assayComponentEndpointName": "ATG_AP_1_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_AP_1_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_AP_1_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene FOS and JUN. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 33, + "assayComponentName": "ATG_AP_1_CIS", + "assayComponentDesc": "ATG_AP_1_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene AP-1, which is responsive to the endogenous human FBJ murine osteosarcoma viral oncogene homolog and jun proto-oncogene [GeneSymbol:FOS & JUN | GeneID:2353 & 3725 | Uniprot_SwissProt_Accession:P01100 & P05412].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "AP-1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 134, + "geneName": "FBJ murine osteosarcoma viral oncogene homolog", + "description": null, + "geneSymbol": "FOS", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2353, + "officialSymbol": "FOS", + "officialFullName": "FBJ murine osteosarcoma viral oncogene homolog", + "uniprotAccessionNumber": "P01100" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 65, + "assayComponentEndpointName": "ATG_AP_2_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_AP_2_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_AP_2_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TFAP2A and TFAP2B and TFAP2D. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic helix-turn-helix leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic helix-turn-helix leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 34, + "assayComponentName": "ATG_AP_2_CIS", + "assayComponentDesc": "ATG_AP_2_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene AP-2, which is responsive to the endogenous human transcription factor AP-2 alpha (activating enhancer binding protein 2 alpha) and transcription factor AP-2 beta (activating enhancer binding protein 2 beta) and transcription factor AP-2 delta (activating enhancer binding protein 2 delta) [GeneSymbol:TFAP2A & TFAP2B & TFAP2D | GeneID:7020 & 7021 & 83741 | Uniprot_SwissProt_Accession:P05549 & Q92481 & Q7Z6R9].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "AP-2 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 314, + "geneName": "transcription factor AP-2 alpha (activating enhancer binding protein 2 alpha)", + "description": null, + "geneSymbol": "TFAP2A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7020, + "officialSymbol": "TFAP2A", + "officialFullName": "transcription factor AP-2 alpha (activating enhancer binding protein 2 alpha)", + "uniprotAccessionNumber": "P05549" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 66, + "assayComponentEndpointName": "ATG_BRE_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_BRE_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_BRE_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene SMAD1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is Smad protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "Smad protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 35, + "assayComponentName": "ATG_BRE_CIS", + "assayComponentDesc": "ATG_BRE_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element BRE, which is responsive to the endogenous human SMAD family member 1 [GeneSymbol:SMAD1 | GeneID:4086 | Uniprot_SwissProt_Accession:Q15797].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "BRE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 196, + "geneName": "SMAD family member 1", + "description": null, + "geneSymbol": "SMAD1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4086, + "officialSymbol": "SMAD1", + "officialFullName": "SMAD family member 1", + "uniprotAccessionNumber": "Q15797" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 67, + "assayComponentEndpointName": "ATG_C_EBP_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_C_EBP_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_C_EBP_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene CEBPB. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 36, + "assayComponentName": "ATG_C_EBP_CIS", + "assayComponentDesc": "ATG_C_EBP_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene C/EBP, which is responsive to the endogenous human CCAAT/enhancer binding protein (C/EBP), beta [GeneSymbol:CEBPB | GeneID:1051 | Uniprot_SwissProt_Accession:P17676].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "C/EBP RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 58, + "geneName": "CCAAT/enhancer binding protein (C/EBP), beta", + "description": null, + "geneSymbol": "CEBPB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1051, + "officialSymbol": "CEBPB", + "officialFullName": "CCAAT/enhancer binding protein (C/EBP), beta", + "uniprotAccessionNumber": "P17676" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 68, + "assayComponentEndpointName": "ATG_CMV_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_CMV_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_CMV_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \n\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 37, + "assayComponentName": "ATG_CMV_CIS", + "assayComponentDesc": "ATG_CMV_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene CMV, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "CMV RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 69, + "assayComponentEndpointName": "ATG_CRE_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_CRE_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_CRE_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene CREB3. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Forskolin", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 38, + "assayComponentName": "ATG_CRE_CIS", + "assayComponentDesc": "ATG_CRE_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element CRE, which is responsive to the endogenous human cAMP responsive element binding protein 3 [GeneSymbol:CREB3 | GeneID:10488 | Uniprot_SwissProt_Accession:O43889].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "CRE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 366, + "geneName": "cAMP responsive element binding protein 3", + "description": null, + "geneSymbol": "CREB3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10488, + "officialSymbol": "CREB3", + "officialFullName": "cAMP responsive element binding protein 3", + "uniprotAccessionNumber": "O43889" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 70, + "assayComponentEndpointName": "ATG_DR4_LXR_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_DR4_LXR_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_DR4_LXR_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR1H2 and NR1H3. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 39, + "assayComponentName": "ATG_DR4_LXR_CIS", + "assayComponentDesc": "ATG_DR4_LXR_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element LXRE, which is responsive to the endogenous human nuclear receptor subfamily 1, group H, member 2 and nuclear receptor subfamily 1, group H, member 3 [GeneSymbol:NR1H2 & NR1H3 | GeneID:7376 & 10062 | Uniprot_SwissProt_Accession:P55055 & Q13133].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "LXRE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 332, + "geneName": "nuclear receptor subfamily 1, group H, member 2", + "description": null, + "geneSymbol": "NR1H2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7376, + "officialSymbol": "NR1H2", + "officialFullName": "nuclear receptor subfamily 1, group H, member 2", + "uniprotAccessionNumber": "P55055" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 71, + "assayComponentEndpointName": "ATG_DR5_RAR_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_DR5_RAR_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_DR5_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RARA and RARB and RARG. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "9-cis-Retinoic acid", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 40, + "assayComponentName": "ATG_DR5_RAR_CIS", + "assayComponentDesc": "ATG_DR5_RAR_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element RARE, which is responsive to the endogenous human retinoic acid receptor, alpha and retinoic acid receptor, beta and retinoic acid receptor, gamma [GeneSymbol:RARA & RARB & RARG | GeneID:5914 & 5915 & 5916 | Uniprot_SwissProt_Accession:P10276 & P10826 & P13631].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "RARE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 279, + "geneName": "retinoic acid receptor, alpha", + "description": null, + "geneSymbol": "RARA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5914, + "officialSymbol": "RARA", + "officialFullName": "retinoic acid receptor, alpha", + "uniprotAccessionNumber": "P10276" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 612, + "assayComponentEndpointName": "NVS_GPCR_bH1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_bH1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_bH1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene HRH1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tripolidine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 349, + "assayComponentName": "NVS_GPCR_bH1", + "assayComponentDesc": "NVS_GPCR_bH1 is one of one assay component(s) measured or calculated from the NVS_GPCR_bH1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Pyrilamine] are indicative of a change in receptor function and kinetics for the cattle histamine receptor H1 [GeneSymbol:HRH1 | GeneID:281231 | Uniprot_SwissProt_Accession:P30546].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Pyrilamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 163, + "assayName": "NVS_GPCR_bH1", + "assayDesc": "NVS_GPCR_bH1 is a biochemical, single-readout assay that uses extracted gene-proteins from Bovine cerebellar membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 9913, + "organism": "bovine", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Bovine cerebellar membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 450, + "geneName": "histamine receptor H1", + "description": null, + "geneSymbol": "HRH1", + "organismId": 4, + "trackStatus": "live", + "entrezGeneId": 281231, + "officialSymbol": "HRH1", + "officialFullName": "histamine receptor H1", + "uniprotAccessionNumber": "P30546" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/448359", + "pmid": 448359, + "title": "Heterogeneity of histamine H1-receptors: species variations in [3H]mepyramine binding of brain membranes", + "author": "Chang RS, Tran VT, Snyder SH", + "citation": "Chang RS, Tran VT, Snyder SH. Heterogeneity of histamine H1-receptors: species variations in [3H]mepyramine binding of brain membranes. J Neurochem. 1979 Jun;32(6):1653-63. PubMed PMID: 448359.", + "otherId": "0", + "citationId": 8, + "otherSource": "" + } + }, + { + "aeid": 613, + "assayComponentEndpointName": "NVS_GPCR_bNPY_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_bNPY_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_bNPY_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene NPY. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "porcine neuropeptide Y", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 350, + "assayComponentName": "NVS_GPCR_bNPY_NonSelective", + "assayComponentDesc": "NVS_GPCR_bNPY_NonSelective is one of one assay component(s) measured or calculated from the NVS_GPCR_bNPY_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Peptide YY] are indicative of a change in receptor function and kinetics for the cattle neuropeptide Y [GeneSymbol:NPY | GeneID:504216 | Uniprot_SwissProt_Accession:Q6RUW3].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Peptide YY", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 164, + "assayName": "NVS_GPCR_bNPY_NonSelective", + "assayDesc": "NVS_GPCR_bNPY_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Bovine hippocampal membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9913, + "organism": "bovine", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Bovine hippocampal membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 462, + "geneName": "neuropeptide Y", + "description": null, + "geneSymbol": "NPY", + "organismId": 4, + "trackStatus": "live", + "entrezGeneId": 504216, + "officialSymbol": "NPY", + "officialFullName": "neuropeptide Y", + "uniprotAccessionNumber": "Q6RUW3" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2170863", + "pmid": 2170863, + "title": "Quantitative autoradiographic distribution of [125I]Bolton-Hunter neuropeptide Y receptor binding sites in rat brain. Comparison with [125I]peptide YY receptor sites", + "author": "Martel JC, Fournier A, St Pierre S, Quirion R", + "citation": "Martel JC, Fournier A, St Pierre S, Quirion R. Quantitative autoradiographic distribution of [125I]Bolton-Hunter neuropeptide Y receptor binding sites in rat brain. Comparison with [125I]peptide YY receptor sites. Neuroscience. 1990;36(1):255-83. PubMed PMID: 2170863.", + "otherId": "0", + "citationId": 35, + "otherSource": "" + } + }, + { + "aeid": 614, + "assayComponentEndpointName": "NVS_GPCR_g5HT4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_g5HT4 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_g5HT4, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Htr4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Serotonin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 351, + "assayComponentName": "NVS_GPCR_g5HT4", + "assayComponentDesc": "NVS_GPCR_g5HT4 is one of one assay component(s) measured or calculated from the NVS_GPCR_g5HT4 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-GR-113808] are indicative of a change in receptor function and kinetics for the domestic guinea pig 5 hydroxytryptamine (serotonin) receptor 4 [GeneSymbol:Htr4 | GeneID:100135548 | Uniprot_SwissProt_Accession:O70528].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-GR-113808", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 165, + "assayName": "NVS_GPCR_g5HT4", + "assayDesc": "NVS_GPCR_g5HT4 is a biochemical, single-readout assay that uses extracted gene-proteins from Guinea pig striatal membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10141, + "organism": "guinea pig", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Guinea pig striatal membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 471, + "geneName": "5 hydroxytryptamine (serotonin) receptor 4", + "description": "provisional", + "geneSymbol": "Htr4", + "organismId": 10, + "trackStatus": "live", + "entrezGeneId": 100135548, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "O70528" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/8358562", + "pmid": 8358562, + "title": "Development of a radioligand binding assay for 5-HT4 receptors in guinea-pig and rat brain", + "author": "Grossman CJ, Kilpatrick GJ, Bunce KT", + "citation": "Grossman CJ, Kilpatrick GJ, Bunce KT. Development of a radioligand binding assay for 5-HT4 receptors in guinea-pig and rat brain. Br J Pharmacol. 1993 Jul;109(3):618-24. PubMed PMID: 8358562; PubMed Central PMCID: PMC2175660.", + "otherId": "0", + "citationId": 159, + "otherSource": "" + } + }, + { + "aeid": 615, + "assayComponentEndpointName": "NVS_GPCR_gANPA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_gANPA was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_gANPA, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Nppa. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the lyase intended target family, where the subfamily is guanylyl cyclase.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "rat ANP", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "lyase", + "intendedTargetFamilySub": "guanylyl cyclase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 352, + "assayComponentName": "NVS_GPCR_gANPA", + "assayComponentDesc": "NVS_GPCR_gANPA is one of one assay component(s) measured or calculated from the NVS_GPCR_gANPA assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Atrial natiuretic peptide] are indicative of a change in receptor function and kinetics for the domestic guinea pig natriuretic peptide A [GeneSymbol:Nppa | GeneID:100135578 | Uniprot_SwissProt_Accession:P27596].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Atrial natiuretic peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 166, + "assayName": "NVS_GPCR_gANPA", + "assayDesc": "NVS_GPCR_gANPA is a biochemical, single-readout assay that uses extracted gene-proteins from Guinea pig cerebellar membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10141, + "organism": "guinea pig", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Guinea pig cerebellar membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 472, + "geneName": "natriuretic peptide A", + "description": "model", + "geneSymbol": "Nppa", + "organismId": 10, + "trackStatus": "live", + "entrezGeneId": 100135578, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P27596" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2408776", + "pmid": 2408776, + "title": "Vascular and adrenal receptors for atrial natriuretic factor in the rat", + "author": "Schiffrin EL, Chartier L, Thibault G, St-Louis J, Cantin M, Genest J", + "citation": "Schiffrin EL, Chartier L, Thibault G, St-Louis J, Cantin M, Genest J. Vascular and adrenal receptors for atrial natriuretic factor in the rat. Circ Res. 1985 Jun;56(6):801-7. PubMed PMID: 2408776.", + "otherId": "0", + "citationId": 45, + "otherSource": "" + } + }, + { + "aeid": 616, + "assayComponentEndpointName": "NVS_GPCR_gBK2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_gBK2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_gBK2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Bdkrb2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Bradykinin TFA salt", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 353, + "assayComponentName": "NVS_GPCR_gBK2", + "assayComponentDesc": "NVS_GPCR_gBK2 is one of one assay component(s) measured or calculated from the NVS_GPCR_gBK2 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Bradykinin] are indicative of a change in receptor function and kinetics for the domestic guinea pig bradykinin receptor, beta 2 [GeneSymbol:Bdkrb2 | GeneID:100135486 | Uniprot_SwissProt_Accession:O70526].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Bradykinin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 167, + "assayName": "NVS_GPCR_gBK2", + "assayDesc": "NVS_GPCR_gBK2 is a biochemical, single-readout assay that uses extracted gene-proteins from Guinea pig ileum membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10141, + "organism": "guinea pig", + "tissue": "intestinal", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Guinea pig ileum membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 468, + "geneName": "bradykinin receptor, beta 2", + "description": "provisional", + "geneSymbol": "Bdkrb2", + "organismId": 10, + "trackStatus": "live", + "entrezGeneId": 100135486, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "O70526" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1315547", + "pmid": 1315547, + "title": "Characterization of solubilized bradykinin B2 receptors from smooth muscle and mucosa of guinea pig ileum", + "author": "Ransom RW, Young GS, Schneck K, Goodman CB", + "citation": "Ransom RW, Young GS, Schneck K, Goodman CB. Characterization of solubilized bradykinin B2 receptors from smooth muscle and mucosa of guinea pig ileum. Biochem Pharmacol. 1992 Apr 15;43(8):1823-7. PubMed PMID: 1315547.", + "otherId": "0", + "citationId": 13, + "otherSource": "" + } + }, + { + "aeid": 617, + "assayComponentEndpointName": "NVS_GPCR_gH2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_gH2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_gH2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Hrh2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tiotidine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 354, + "assayComponentName": "NVS_GPCR_gH2", + "assayComponentDesc": "NVS_GPCR_gH2 is one of one assay component(s) measured or calculated from the NVS_GPCR_gH2 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Aminopotentidine] are indicative of a change in receptor function and kinetics for the domestic guinea pig histamine receptor H2 [GeneSymbol:Hrh2 | GeneID:100135540 | Uniprot_SwissProt_Accession:P47747].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Aminopotentidine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 168, + "assayName": "NVS_GPCR_gH2", + "assayDesc": "NVS_GPCR_gH2 is a biochemical, single-readout assay that uses extracted gene-proteins from Guinea pig striatal membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10141, + "organism": "guinea pig", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Guinea pig striatal membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 470, + "geneName": "histamine receptor H2", + "description": null, + "geneSymbol": "Hrh2", + "organismId": 10, + "trackStatus": "live", + "entrezGeneId": 100135540, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P47747" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1979518", + "pmid": 1979518, + "title": "Three histamine receptors (H1, H2 and H3) visualized in the brain of human and non-human primates", + "author": "Martinez-Mir MI, Pollard H, Moreau J, Arrang JM, Ruat M, Traiffort E, Schwartz JC, Palacios JM", + "citation": "Martinez-Mir MI, Pollard H, Moreau J, Arrang JM, Ruat M, Traiffort E, Schwartz JC, Palacios JM. Three histamine receptors (H1, H2 and H3) visualized in the brain of human and non-human primates. Brain Res. 1990 Sep 3;526(2):322-7. PubMed PMID: 1979518.", + "otherId": "0", + "citationId": 28, + "otherSource": "" + } + }, + { + "aeid": 618, + "assayComponentEndpointName": "NVS_GPCR_gLTB4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_gLTB4 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_gLTB4, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Ltb4r. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Leukotriene B4 (LTB4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 355, + "assayComponentName": "NVS_GPCR_gLTB4", + "assayComponentDesc": "NVS_GPCR_gLTB4 is one of one assay component(s) measured or calculated from the NVS_GPCR_gLTB4 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Leukotriene B4] are indicative of a change in receptor function and kinetics for the domestic guinea pig leukotriene B4 receptor [GeneSymbol:Ltb4r | GeneID:100379538 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Leukotriene B4", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 169, + "assayName": "NVS_GPCR_gLTB4", + "assayDesc": "NVS_GPCR_gLTB4 is a biochemical, single-readout assay that uses extracted gene-proteins from Guinea pig spleen membranes in a tissue-based cell-free assay. Measurements were taken 2 hours after chemical dosing in a 48-well plate.", + "timepointHr": 2.0, + "organismId": 10141, + "organism": "guinea pig", + "tissue": "spleen", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Guinea pig spleen membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 477, + "geneName": "leukotriene B4 receptor", + "description": "provisional", + "geneSymbol": "Ltb4r", + "organismId": 10, + "trackStatus": "live", + "entrezGeneId": 100379538, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2168834", + "pmid": 2168834, + "title": "Evidence for two leukotriene receptor types in the guinea-pig isolated ileum", + "author": "Gardiner PJ, Abram TS, Cuthbert NJ", + "citation": "Gardiner PJ, Abram TS, Cuthbert NJ. Evidence for two leukotriene receptor types in the guinea-pig isolated ileum. Eur J Pharmacol. 1990 Jul 3;182(2):291-9. PubMed PMID: 2168834.", + "otherId": "0", + "citationId": 34, + "otherSource": "" + } + }, + { + "aeid": 619, + "assayComponentEndpointName": "NVS_GPCR_gLTD4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_gLTD4 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_gLTD4, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Cysltr1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Leukotriene D4 (LTD4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 356, + "assayComponentName": "NVS_GPCR_gLTD4", + "assayComponentDesc": "NVS_GPCR_gLTD4 is one of one assay component(s) measured or calculated from the NVS_GPCR_gLTD4 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Leukotriene D4] are indicative of a change in receptor function and kinetics for the domestic guinea pig cysteinyl leukotriene receptor 1 [GeneSymbol:Cysltr1 | GeneID:100135514 | Uniprot_SwissProt_Accession:Q2NNR5].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Leukotriene D4", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 170, + "assayName": "NVS_GPCR_gLTD4", + "assayDesc": "NVS_GPCR_gLTD4 is a biochemical, single-readout assay that uses extracted gene-proteins from Guinea pig lung membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10141, + "organism": "guinea pig", + "tissue": "lung", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Guinea pig lung membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 469, + "geneName": "cysteinyl leukotriene receptor 1", + "description": "provisional", + "geneSymbol": "Cysltr1", + "organismId": 10, + "trackStatus": "live", + "entrezGeneId": 100135514, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "Q2NNR5" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2397744", + "pmid": 2397744, + "title": "The inhibition of [3H]leukotriene D4 binding to guinea-pig lung membranes. The correlation of binding affinity with activity on the guinea-pig ileum", + "author": "Norman P, Abram TS, Cuthbert NJ, Gardiner PJ", + "citation": "Norman P, Abram TS, Cuthbert NJ, Gardiner PJ. The inhibition of [3H]leukotriene D4 binding to guinea-pig lung membranes. The correlation of binding affinity with activity on the guinea-pig ileum. Eur J Pharmacol. 1990 Jul 3;182(2):301-12. PubMed PMID: 2397744.", + "otherId": "0", + "citationId": 43, + "otherSource": "" + } + }, + { + "aeid": 620, + "assayComponentEndpointName": "NVS_GPCR_gMPeripheral_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_gMPeripheral_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_gMPeripheral_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Chrm3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Atropine sulfate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 357, + "assayComponentName": "NVS_GPCR_gMPeripheral_NonSelective", + "assayComponentDesc": "NVS_GPCR_gMPeripheral_NonSelective is one of one assay component(s) measured or calculated from the NVS_GPCR_gMPeripheral_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Quinuclidinyl benzilate] are indicative of a change in receptor function and kinetics for the domestic guinea pig cholinergic receptor, muscarinic 3, cardiac [GeneSymbol:Chrm3 | GeneID:100379235 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Quinuclidinyl benzilate", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 171, + "assayName": "NVS_GPCR_gMPeripheral_NonSelective", + "assayDesc": "NVS_GPCR_gMPeripheral_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Guinea pig bladder membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10141, + "organism": "guinea pig", + "tissue": "bladder", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Guinea pig bladder membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 476, + "geneName": "cholinergic receptor, muscarinic 3, cardiac", + "description": "provisional", + "geneSymbol": "Chrm3", + "organismId": 10, + "trackStatus": "live", + "entrezGeneId": 100379235, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/6546770", + "pmid": 6546770, + "title": "Comparison of [3H]pirenzepine and [3H]quinuclidinylbenzilate binding to muscarinic cholinergic receptors in rat brain", + "author": "Luthin GR, Wolfe BB", + "citation": "Luthin GR, Wolfe BB. Comparison of [3H]pirenzepine and [3H]quinuclidinylbenzilate binding to muscarinic cholinergic receptors in rat brain. J Pharmacol Exp Ther. 1984 Mar;228(3):648-55. PubMed PMID: 6546770.", + "otherId": "0", + "citationId": 128, + "otherSource": "" + } + }, + { + "aeid": 621, + "assayComponentEndpointName": "NVS_GPCR_gOpiateK", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_gOpiateK was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_gOpiateK, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Oprk1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "U-69593", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 358, + "assayComponentName": "NVS_GPCR_gOpiateK", + "assayComponentDesc": "NVS_GPCR_gOpiateK is one of one assay component(s) measured or calculated from the NVS_GPCR_gOpiateK assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-U-69593] are indicative of a change in receptor function and kinetics for the domestic guinea pig opioid receptor, kappa 1 [GeneSymbol:Oprk1 | GeneID:100135587 | Uniprot_SwissProt_Accession:P41144].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-U-69593", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 172, + "assayName": "NVS_GPCR_gOpiateK", + "assayDesc": "NVS_GPCR_gOpiateK is a biochemical, single-readout assay that uses extracted gene-proteins from Guinea pig cerebellar membranes in a tissue-based cell-free assay. Measurements were taken 2 hours after chemical dosing in a 48-well plate.", + "timepointHr": 2.0, + "organismId": 10141, + "organism": "guinea pig", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Guinea pig cerebellar membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 473, + "geneName": "opioid receptor, kappa 1", + "description": "provisional", + "geneSymbol": "Oprk1", + "organismId": 10, + "trackStatus": "live", + "entrezGeneId": 100135587, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P41144" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1336192", + "pmid": 1336192, + "title": "Interaction of opioid peptides and other drugs with multiple kappa receptors in rat and human brain", + "author": "Rothman RB, Bykov V, Xue BG, Xu H, De Costa BR, Jacobson AE, Rice KC, Kleinman JE, Brady LS", + "citation": "Rothman RB, Bykov V, Xue BG, Xu H, De Costa BR, Jacobson AE, Rice KC, Kleinman JE, Brady LS. Interaction of opioid peptides and other drugs with multiple kappa receptors in rat and human brain. Evidence for species differences. Peptides. 1992 Sep-Oct;13(5):977-87. PubMed PMID: 1336192.", + "otherId": "0", + "citationId": 16, + "otherSource": "" + } + }, + { + "aeid": 622, + "assayComponentEndpointName": "NVS_GPCR_h5HT2A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_h5HT2A was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_h5HT2A, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene HTR2A. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ketanserin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 359, + "assayComponentName": "NVS_GPCR_h5HT2A", + "assayComponentDesc": "NVS_GPCR_h5HT2A is one of one assay component(s) measured or calculated from the NVS_GPCR_h5HT2A assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Ketanserin] are indicative of a change in receptor function and kinetics for the human 5-hydroxytryptamine (serotonin) receptor 2A, G protein-coupled [GeneSymbol:HTR2A | GeneID:3356 | Uniprot_SwissProt_Accession:P28223].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Ketanserin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 173, + "assayName": "NVS_GPCR_h5HT2A", + "assayDesc": "NVS_GPCR_h5HT2A is a biochemical, single-readout assay that uses extracted gene-proteins from Human cortex in a tissue-based cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 48-well plate.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Human cortex", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 164, + "geneName": "5-hydroxytryptamine (serotonin) receptor 2A, G protein-coupled", + "description": null, + "geneSymbol": "HTR2A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3356, + "officialSymbol": "HTR2A", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 2A, G protein-coupled", + "uniprotAccessionNumber": "P28223" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7099138", + "pmid": 7099138, + "title": "[3H]Ketanserin (R 41468), a selective 3H-ligand for serotonin2 receptor binding sites. Binding properties, brain distribution, and functional role", + "author": "Leysen JE, Niemegeers CJ, Van Nueten JM, Laduron PM", + "citation": "Leysen JE, Niemegeers CJ, Van Nueten JM, Laduron PM. [3H]Ketanserin (R 41468), a selective 3H-ligand for serotonin2 receptor binding sites. Binding properties, brain distribution, and functional role. Mol Pharmacol. 1982 Mar;21(2):301-14. PubMed PMID: 7099138.", + "otherId": "0", + "citationId": 133, + "otherSource": "" + } + }, + { + "aeid": 623, + "assayComponentEndpointName": "NVS_GPCR_h5HT5A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_h5HT5A was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_h5HT5A, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene HTR5A. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methiothepin mesylate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 360, + "assayComponentName": "NVS_GPCR_h5HT5A", + "assayComponentDesc": "NVS_GPCR_h5HT5A is one of one assay component(s) measured or calculated from the NVS_GPCR_h5HT5A assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-lysergic acid diethylamide] are indicative of a change in receptor function and kinetics for the human 5-hydroxytryptamine (serotonin) receptor 5A, G protein-coupled [GeneSymbol:HTR5A | GeneID:3361 | Uniprot_SwissProt_Accession:P47898].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-lysergic acid diethylamide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 174, + "assayName": "NVS_GPCR_h5HT5A", + "assayDesc": "NVS_GPCR_h5HT5A is a biochemical, single-readout assay that uses extracted gene-proteins from HEK293 in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "HEK293", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 167, + "geneName": "5-hydroxytryptamine (serotonin) receptor 5A, G protein-coupled", + "description": null, + "geneSymbol": "HTR5A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3361, + "officialSymbol": "HTR5A", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 5A, G protein-coupled", + "uniprotAccessionNumber": "P47898" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7988681", + "pmid": 7988681, + "title": "Cloning and characterisation of the human 5-HT5A serotonin receptor", + "author": "Rees S, den Daas I, Foord S, Goodson S, Bull D, Kilpatrick G, Lee M", + "citation": "Rees S, den Daas I, Foord S, Goodson S, Bull D, Kilpatrick G, Lee M. Cloning and characterisation of the human 5-HT5A serotonin receptor. FEBS Lett. 1994 Dec 5;355(3):242-6. PubMed PMID: 7988681.", + "otherId": "0", + "citationId": 151, + "otherSource": "" + } + }, + { + "aeid": 624, + "assayComponentEndpointName": "NVS_GPCR_h5HT6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_h5HT6 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_h5HT6, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene HTR6. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methiothepin mesylate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 361, + "assayComponentName": "NVS_GPCR_h5HT6", + "assayComponentDesc": "NVS_GPCR_h5HT6 is one of one assay component(s) measured or calculated from the NVS_GPCR_h5HT6 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-lysergic acid diethylamide] are indicative of a change in receptor function and kinetics for the human 5-hydroxytryptamine (serotonin) receptor 6, G protein-coupled [GeneSymbol:HTR6 | GeneID:3362 | Uniprot_SwissProt_Accession:P50406].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-lysergic acid diethylamide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 175, + "assayName": "NVS_GPCR_h5HT6", + "assayDesc": "NVS_GPCR_h5HT6 is a biochemical, single-readout assay that uses extracted gene-proteins from HEK293 in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "HEK293", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 168, + "geneName": "5-hydroxytryptamine (serotonin) receptor 6, G protein-coupled", + "description": null, + "geneSymbol": "HTR6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3362, + "officialSymbol": "HTR6", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 6, G protein-coupled", + "uniprotAccessionNumber": "P50406" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7680751", + "pmid": 7680751, + "title": "Cloning and expression of a novel serotonin receptor with high affinity for tricyclic psychotropic drugs", + "author": "Monsma FJ Jr, Shen Y, Ward RP, Hamblin MW, Sibley DR", + "citation": "Monsma FJ Jr, Shen Y, Ward RP, Hamblin MW, Sibley DR. Cloning and expression of a novel serotonin receptor with high affinity for tricyclic psychotropic drugs. Mol Pharmacol. 1993 Mar;43(3):320-7. PubMed PMID: 7680751.", + "otherId": "0", + "citationId": 142, + "otherSource": "" + } + }, + { + "aeid": 625, + "assayComponentEndpointName": "NVS_GPCR_h5HT7", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_h5HT7 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_h5HT7, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene HTR7. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "5-carboxamidotryptamine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 362, + "assayComponentName": "NVS_GPCR_h5HT7", + "assayComponentDesc": "NVS_GPCR_h5HT7 is one of one assay component(s) measured or calculated from the NVS_GPCR_h5HT7 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-lysergic acid diethylamide] are indicative of a change in receptor function and kinetics for the human 5-hydroxytryptamine (serotonin) receptor 7, adenylate cyclase-coupled [GeneSymbol:HTR7 | GeneID:3363 | Uniprot_SwissProt_Accession:P34969].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-lysergic acid diethylamide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 176, + "assayName": "NVS_GPCR_h5HT7", + "assayDesc": "NVS_GPCR_h5HT7 is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 169, + "geneName": "5-hydroxytryptamine (serotonin) receptor 7, adenylate cyclase-coupled", + "description": null, + "geneSymbol": "HTR7", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3363, + "officialSymbol": "HTR7", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 7, adenylate cyclase-coupled", + "uniprotAccessionNumber": "P34969" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/8394362", + "pmid": 8394362, + "title": "Molecular cloning and expression of a 5-hydroxytryptamine7 serotonin receptor subtype", + "author": "Shen Y, Monsma FJ Jr, Metcalf MA, Jose PA, Hamblin MW, Sibley DR", + "citation": "Shen Y, Monsma FJ Jr, Metcalf MA, Jose PA, Hamblin MW, Sibley DR. Molecular cloning and expression of a 5-hydroxytryptamine7 serotonin receptor subtype. J Biol Chem. 1993 Aug 25;268(24):18200-4. PubMed PMID: 8394362.", + "otherId": "0", + "citationId": 164, + "otherSource": "" + } + }, + { + "aeid": 626, + "assayComponentEndpointName": "NVS_GPCR_hAdoRA1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hAdoRA1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hAdoRA1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene ADORA1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "2-chloroadenosine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 363, + "assayComponentName": "NVS_GPCR_hAdoRA1", + "assayComponentDesc": "NVS_GPCR_hAdoRA1 is one of one assay component(s) measured or calculated from the NVS_GPCR_hAdoRA1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-8-Cyclopentyl-1,3-dipropylxanthine] are indicative of a change in receptor function and kinetics for the human adenosine A1 receptor [GeneSymbol:ADORA1 | GeneID:134 | Uniprot_SwissProt_Accession:P30542].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-8-Cyclopentyl-1,3-dipropylxanthine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 177, + "assayName": "NVS_GPCR_hAdoRA1", + "assayDesc": "NVS_GPCR_hAdoRA1 is a biochemical, single-readout assay that uses extracted gene-proteins from Human cortical membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Human cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 10, + "geneName": "adenosine A1 receptor", + "description": null, + "geneSymbol": "ADORA1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 134, + "officialSymbol": "ADORA1", + "officialFullName": "adenosine A1 receptor", + "uniprotAccessionNumber": "P30542" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/3574492", + "pmid": 3574492, + "title": "Binding of the A1-selective adenosine antagonist 8-cyclopentyl-1,3-dipropylxanthine to rat brain membranes", + "author": "Bruns RF, Fergus JH, Badger EW, Bristol JA, Santay LA, Hartman JD, Hays SJ, Huang CC", + "citation": "Bruns RF, Fergus JH, Badger EW, Bristol JA, Santay LA, Hartman JD, Hays SJ, Huang CC. Binding of the A1-selective adenosine antagonist 8-cyclopentyl-1,3-dipropylxanthine to rat brain membranes. Naunyn Schmiedebergs Arch Pharmacol. 1987 Jan;335(1):59-63. PubMed PMID: 3574492.", + "otherId": "0", + "citationId": 100, + "otherSource": "" + } + }, + { + "aeid": 627, + "assayComponentEndpointName": "NVS_GPCR_hAdoRA2a", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hAdoRA2a was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hAdoRA2a, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene ADORA2A. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "5\"-N-ethylcarboxamidoadenosine (NECA)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 364, + "assayComponentName": "NVS_GPCR_hAdoRA2a", + "assayComponentDesc": "NVS_GPCR_hAdoRA2a is one of one assay component(s) measured or calculated from the NVS_GPCR_hAdoRA2a assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-CGS 21680] are indicative of a change in receptor function and kinetics for the human adenosine A2a receptor [GeneSymbol:ADORA2A | GeneID:135 | Uniprot_SwissProt_Accession:P29274].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-CGS 21680", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 178, + "assayName": "NVS_GPCR_hAdoRA2a", + "assayDesc": "NVS_GPCR_hAdoRA2a is a biochemical, single-readout assay that uses extracted gene-proteins from HEK293 in a cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 96-well plate.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "HEK293", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 11, + "geneName": "adenosine A2a receptor", + "description": null, + "geneSymbol": "ADORA2A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 135, + "officialSymbol": "ADORA2A", + "officialFullName": "adenosine A2a receptor", + "uniprotAccessionNumber": "P29274" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2600819", + "pmid": 2600819, + "title": "[3H]CGS 21680, a selective A2 adenosine receptor agonist directly labels A2 receptors in rat brain", + "author": "Jarvis MF, Schulz R, Hutchison AJ, Do UH, Sills MA, Williams M", + "citation": "Jarvis MF, Schulz R, Hutchison AJ, Do UH, Sills MA, Williams M. [3H]CGS 21680, a selective A2 adenosine receptor agonist directly labels A2 receptors in rat brain. J Pharmacol Exp Ther. 1989 Dec;251(3):888-93. PubMed PMID: 2600819.", + "otherId": "0", + "citationId": 63, + "otherSource": "" + } + }, + { + "aeid": 2547, + "assayComponentEndpointName": "UKN5_HCS_SBAD2_cell_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "The assay endpoint UKN5_HCS_SBAD2_cell_viability was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of viability reporter, gain or loss-of-signal activity can be used to understand viability effects. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is viability.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "nucleus", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "viability", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 2501, + "assayComponentName": "UKN5_HCS_SBAD2_cell_viability", + "assayComponentDesc": "UKN5_HCS_SBAD2_cell_viability is an assay component measured from the UKN5_HCS_SBAD2 assay. It is designed to make measurements of enzyme activity, a form of viability reporter, as detected with Fluorescence intensity signals by HCS Fluorescent Imaging.", + "assayComponentTargetDesc": "Changes in the number of Hoechst labelled nuclei are indicative of viability.", + "parameterReadoutType": "multiplexed", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "cytotoxicity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "HCS Fluorescent Imaging", + "keyAssayReagentType": "stain;stain", + "keyAssayReagent": "calcein-AM; Hoechst 33340", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "number of Hoechst labelled nuclei", + "aid": 691, + "assayName": "UKN5_HCS_SBAD2", + "assayDesc": "UKN5_HCS_SBAD2 is a cell-based, multiplexed-readout assay screening for neurite outgrowth and cell viability that uses SBAD2 (peripheral neurons differentiated from iPSC), a human peripheral nervous system cell line, with measurements taken at 3 hours after chemical dosing in a microplate: 96-well plate. UKN5, also referred to as PeriTox, is an assay that uses human iPSC line SBAD2 as a model of peripheral neurons. Following 24 hr chemical exposures in multi-well plates, neurite area is evaluated as a marker of neurite outgrowth using high-content imaging of cells stained with calcein-AM. Cell viability is assessed using stain Hoechst H-33342.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "peripheral nervous system", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "SBAD2 (peripheral neurons differentiated from iPSC)", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 27, + "assaySourceName": "UKN", + "assaySourceLongName": "University of Konstanz", + "assaySourceDesc": "The Leist research group at the University of Konstanz conducts high content imaging assays for neurotoxicity.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1007/s00204-013-1072-y", + "url": "https://pubmed.ncbi.nlm.nih.gov/23670202/", + "pmid": 23670202, + "title": "Evaluation of a human neurite growth assay as specific screen for developmental neurotoxicants", + "author": "Krug AK, Balmer NV, Matt F, Schönenberger F, Merhof D, Leist M", + "citation": "Krug AK, Balmer NV, Matt F, Schönenberger F, Merhof D, Leist M. Evaluation of a human neurite growth assay as specific screen for developmental neurotoxicants. Arch Toxicol. 2013 Dec;87(12):2215-31. doi: 10.1007/s00204-013-1072-y. Epub 2013 May 14. PMID: 23670202.", + "otherId": "0", + "citationId": 278, + "otherSource": "" + } + }, + { + "aeid": 2549, + "assayComponentEndpointName": "ERF_CR_ADME_hCYP2A6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ADME_hCYP2A6 was analyzed at the assay endpoint, ERF_CR_ADME_hCYP2A6, in the positive analysis fitting direction relative to acetonitrile as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CYP2A6. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is steroidogenesis-related.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp ", + "intendedTargetFamilySub": "steroidogenesis-related", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2502, + "assayComponentName": "ERF_CR_ADME_hCYP2A6", + "assayComponentDesc": "ERF_CR_ADME_hCYP2A6 is an assay component calculated from the ERF_CR_ADME_hCYP2A6 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity of 7-hydroxy-coumarin with fluorimetry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity of 7-hydroxy-coumarin produced from the regulation of catalytic activity reaction involving the key substrate, Coumarin, are indicative of changes in enzyme function and kinetics related to the gene CYP2A6.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorimetry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Coumarin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 812, + "assayName": "ERF_CR_ADME_hCYP2A6", + "assayDesc": "ERF_CR_ADME_hCYP2A6 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See CYP2A6 inhibition (recombinant- coumarin substrate).", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cyp", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 80, + "geneName": "cytochrome P450, family 2, subfamily A, polypeptide 6", + "description": null, + "geneSymbol": "CYP2A6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1548, + "officialSymbol": "CYP2A6", + "officialFullName": "cytochrome P450, family 2, subfamily A, polypeptide 6", + "uniprotAccessionNumber": "P11509" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2550, + "assayComponentEndpointName": "ERF_CR_ADME_hCYP2B6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ADME_hCYP2B6 was analyzed at the assay endpoint, ERF_CR_ADME_hCYP2B6, in the positive analysis fitting direction relative to acetonitrile as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CYP2B6. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is steroidogenesis-related.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp ", + "intendedTargetFamilySub": "steroidogenesis-related", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2503, + "assayComponentName": "ERF_CR_ADME_hCYP2B6", + "assayComponentDesc": "ERF_CR_ADME_hCYP2B6 is an assay component calculated from the ERF_CR_ADME_hCYP2B6 assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity of HFC with fluorimetry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity of HFC produced from the regulation of catalytic activity reaction involving the key substrate, 7-ethoxy-4-trifluoromethylcoumarin (EFC), are indicative of changes in enzyme function and kinetics related to the gene CYP2B6.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorimetry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-ethoxy-4-trifluoromethylcoumarin (EFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 816, + "assayName": "ERF_CR_ADME_hCYP2B6", + "assayDesc": "ERF_CR_ADME_hCYP2B6 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate. See CYP2B6 inhibition (recombinant, EFC substrate).", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cyp", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 82, + "geneName": "cytochrome P450, family 2, subfamily B, polypeptide 6", + "description": null, + "geneSymbol": "CYP2B6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1555, + "officialSymbol": "CYP2B6", + "officialFullName": "cytochrome P450, family 2, subfamily B, polypeptide 6", + "uniprotAccessionNumber": "P20813" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 2551, + "assayComponentEndpointName": "ERF_CR_ADME_hCYP2C19_CEC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ERF_CR_ADME_hCYP2C19_CEC was analyzed at the assay endpoint, ERF_CR_ADME_hCYP2C19_CEC, in the positive analysis fitting direction relative to acetonitrile as the negative control and baseline of activity. Using a type of enzyme reporter, loss-of-signal activity can be used to understand changes in enzymatic activity as they relate to gene CYP2C19. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is steroidogenesis-related.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp ", + "intendedTargetFamilySub": "steroidogenesis-related", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 2504, + "assayComponentName": "ERF_CR_ADME_hCYP2C19_CEC", + "assayComponentDesc": "ERF_CR_ADME_hCYP2C19_CEC is an assay component calculated from the ERF_CR_ADME_hCYP2C19_CEC assay. It is designed to measure enzyme activity using a type of enzyme reporter as detected by fluorescence intensity of HFC with fluorimetry technology.", + "assayComponentTargetDesc": "Changes in fluorescence intensity of HFC produced from the regulation of catalytic activity reaction involving the key substrate, CEC, are indicative of changes in enzyme function and kinetics related to the gene CYP2C19.", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorimetry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CEC", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 808, + "assayName": "ERF_CR_ADME_hCYP2C19_CEC", + "assayDesc": "ERF_CR_ADME_hCYP2C19_CEC is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.83 hour after chemical dosing in a 96-well plate. See CYP2C19 inhibition (recombinant, CEC substrate).", + "timepointHr": 0.83, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "human recombinant cyp", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 0.0, + "asid": 28, + "assaySourceName": "ERF", + "assaySourceLongName": "Eurofins", + "assaySourceDesc": "Eurofins is an international group of laboratories headquartered in Luxembourg, providing testing and support services to the pharmaceutical, food, environmental, agriscience and consumer products industries and to governments.", + "gene": { + "geneId": 83, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "description": null, + "geneSymbol": "CYP2C19", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1557, + "officialSymbol": "CYP2C19", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "uniprotAccessionNumber": "P33261" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 632, + "assayComponentEndpointName": "NVS_GPCR_hAdrb3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hAdrb3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hAdrb3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene ADRB3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Propranolol HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 369, + "assayComponentName": "NVS_GPCR_hAdrb3", + "assayComponentDesc": "NVS_GPCR_hAdrb3 is one of one assay component(s) measured or calculated from the NVS_GPCR_hAdrb3 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-(-)-Iodocyanopindolol] are indicative of a change in receptor function and kinetics for the human adrenoceptor beta 3 [GeneSymbol:ADRB3 | GeneID:155 | Uniprot_SwissProt_Accession:P13945].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-(-)-Iodocyanopindolol", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 183, + "assayName": "NVS_GPCR_hAdrb3", + "assayDesc": "NVS_GPCR_hAdrb3 is a biochemical, single-readout assay that uses extracted gene-proteins from SK-N-MC pretreated with isoproteronol and 8-bromo-cAMP in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "SK-N-MC pretreated with isoproteronol and 8-bromo-cAMP", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 17, + "geneName": "adrenoceptor beta 3", + "description": null, + "geneSymbol": "ADRB3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 155, + "officialSymbol": "ADRB3", + "officialFullName": "adrenoceptor beta 3", + "uniprotAccessionNumber": "P13945" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7996434", + "pmid": 7996434, + "title": "Influence of cell type upon the desensitization of the beta 3-adrenergic receptor", + "author": "Chaudhry A, Granneman JG", + "citation": "Chaudhry A, Granneman JG. Influence of cell type upon the desensitization of the beta 3-adrenergic receptor. J Pharmacol Exp Ther. 1994 Dec;271(3):1253-8. PubMed PMID: 7996434.", + "otherId": "0", + "citationId": 152, + "otherSource": "" + } + }, + { + "aeid": 633, + "assayComponentEndpointName": "NVS_GPCR_hAT1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hAT1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hAT1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene AGTR1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Angiotensin II", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 370, + "assayComponentName": "NVS_GPCR_hAT1", + "assayComponentDesc": "NVS_GPCR_hAT1 is one of one assay component(s) measured or calculated from the NVS_GPCR_hAT1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [Sar1,[125I-Try4],Ile8-Angiotensin II] are indicative of a change in receptor function and kinetics for the human angiotensin II receptor, type 1 [GeneSymbol:AGTR1 | GeneID:185 | Uniprot_SwissProt_Accession:P30556].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "Sar1,[125I-Try4],Ile8-Angiotensin II", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 184, + "assayName": "NVS_GPCR_hAT1", + "assayDesc": "NVS_GPCR_hAT1 is a biochemical, single-readout assay that uses extracted gene-proteins from KAN-TS in a tissue-based cell-free assay. Measurements were taken 3 hours after chemical dosing in a 48-well plate.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "KAN-TS", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 19, + "geneName": "angiotensin II receptor, type 1", + "description": null, + "geneSymbol": "AGTR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 185, + "officialSymbol": "AGTR1", + "officialFullName": "angiotensin II receptor, type 1", + "uniprotAccessionNumber": "P30556" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/187587", + "pmid": 187587, + "title": "Angiotensin II binding to mammalian brain membranes", + "author": "Bennett JP Jr, Snyder SH", + "citation": "Bennett JP Jr, Snyder SH. Angiotensin II binding to mammalian brain membranes. J Biol Chem. 1976 Dec 10;251(23):7423-30. PubMed PMID: 187587.", + "otherId": "0", + "citationId": 4, + "otherSource": "" + } + }, + { + "aeid": 634, + "assayComponentEndpointName": "NVS_GPCR_hC5a", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hC5a was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hC5a, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene C5AR1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "human rC5a", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 371, + "assayComponentName": "NVS_GPCR_hC5a", + "assayComponentDesc": "NVS_GPCR_hC5a is one of one assay component(s) measured or calculated from the NVS_GPCR_hC5a assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-BH-rC5a] are indicative of a change in receptor function and kinetics for the human complement component 5a receptor 1 [GeneSymbol:C5AR1 | GeneID:728 | Uniprot_SwissProt_Accession:P21730].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-BH-rC5a", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 185, + "assayName": "NVS_GPCR_hC5a", + "assayDesc": "NVS_GPCR_hC5a is a biochemical, single-readout assay that uses extracted gene-proteins from U937 in a cell-free assay. Measurements were taken 2 hours after chemical dosing in a 96-well plate.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "U937", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 38, + "geneName": "complement component 5a receptor 1", + "description": null, + "geneSymbol": "C5AR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 728, + "officialSymbol": "C5AR1", + "officialFullName": "complement component 5a receptor 1", + "uniprotAccessionNumber": "P21730" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2153739", + "pmid": 2153739, + "title": "The role of formylpeptide receptors, C5a receptors, and cytosolic-free calcium in neutrophil priming", + "author": "Zimmerli W, Reber AM, Dahinden CA", + "citation": "Zimmerli W, Reber AM, Dahinden CA. The role of formylpeptide receptors, C5a receptors, and cytosolic-free calcium in neutrophil priming. J Infect Dis. 1990 Feb;161(2):242-9. PubMed PMID: 2153739.", + "otherId": "0", + "citationId": 30, + "otherSource": "" + } + }, + { + "aeid": 635, + "assayComponentEndpointName": "NVS_GPCR_hDRD1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hDRD1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hDRD1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene DRD1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "R(+)-SCH 23390", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 372, + "assayComponentName": "NVS_GPCR_hDRD1", + "assayComponentDesc": "NVS_GPCR_hDRD1 is one of one assay component(s) measured or calculated from the NVS_GPCR_hDRD1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-SCH 23390] are indicative of a change in receptor function and kinetics for the human dopamine receptor D1 [GeneSymbol:DRD1 | GeneID:1812 | Uniprot_SwissProt_Accession:P21728].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-SCH 23390", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 186, + "assayName": "NVS_GPCR_hDRD1", + "assayDesc": "NVS_GPCR_hDRD1 is a biochemical, single-readout assay that uses extracted gene-proteins from HEK293 in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "HEK293", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 99, + "geneName": "dopamine receptor D1", + "description": null, + "geneSymbol": "DRD1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1812, + "officialSymbol": "DRD1", + "officialFullName": "dopamine receptor D1", + "uniprotAccessionNumber": "P21728" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/6387355", + "pmid": 6387355, + "title": "Characterization of the binding of 3H-SCH 23390, a selective D-1 receptor antagonist ligand, in rat striatum", + "author": "Billard W, Ruperto V, Crosby G, Iorio LC, Barnett A", + "citation": "Billard W, Ruperto V, Crosby G, Iorio LC, Barnett A. Characterization of the binding of 3H-SCH 23390, a selective D-1 receptor antagonist ligand, in rat striatum. Life Sci. 1984 Oct 29;35(18):1885-93. PubMed PMID: 6387355.", + "otherId": "0", + "citationId": 124, + "otherSource": "" + } + }, + { + "aeid": 636, + "assayComponentEndpointName": "NVS_GPCR_hDRD2s", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hDRD2s was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hDRD2s, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene DRD2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Haloperidol", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 373, + "assayComponentName": "NVS_GPCR_hDRD2s", + "assayComponentDesc": "NVS_GPCR_hDRD2s is one of one assay component(s) measured or calculated from the NVS_GPCR_hDRD2s assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Raclopride] are indicative of a change in receptor function and kinetics for the human dopamine receptor D2 [GeneSymbol:DRD2 | GeneID:1813 | Uniprot_SwissProt_Accession:P14416].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Raclopride", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 187, + "assayName": "NVS_GPCR_hDRD2s", + "assayDesc": "NVS_GPCR_hDRD2s is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 96-well plate.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 100, + "geneName": "dopamine receptor D2", + "description": null, + "geneSymbol": "DRD2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1813, + "officialSymbol": "DRD2", + "officialFullName": "dopamine receptor D2", + "uniprotAccessionNumber": "P14416" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/6149442", + "pmid": 6149442, + "title": "125I-Spiperone: a novel ligand for D2 dopamine receptors", + "author": "Gundlach AL, Largent BL, Snyder SH", + "citation": "Gundlach AL, Largent BL, Snyder SH. 125I-Spiperone: a novel ligand for D2 dopamine receptors. Life Sci. 1984 Nov 5;35(19):1981-8. PubMed PMID: 6149442.", + "otherId": "0", + "citationId": 112, + "otherSource": "" + } + }, + { + "aeid": 637, + "assayComponentEndpointName": "NVS_GPCR_hDRD4.4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hDRD4.4 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hDRD4.4, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene DRD4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Haloperidol", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 374, + "assayComponentName": "NVS_GPCR_hDRD4.4", + "assayComponentDesc": "NVS_GPCR_hDRD4.4 is one of one assay component(s) measured or calculated from the NVS_GPCR_hDRD4.4 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-YM-09151-2] are indicative of a change in receptor function and kinetics for the human dopamine receptor D4 [GeneSymbol:DRD4 | GeneID:1815 | Uniprot_SwissProt_Accession:P21917].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-YM-09151-2", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 188, + "assayName": "NVS_GPCR_hDRD4.4", + "assayDesc": "NVS_GPCR_hDRD4.4 is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 101, + "geneName": "dopamine receptor D4", + "description": null, + "geneSymbol": "DRD4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1815, + "officialSymbol": "DRD4", + "officialFullName": "dopamine receptor D4", + "uniprotAccessionNumber": "P21917" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1319557", + "pmid": 1319557, + "title": "Multiple dopamine D4 receptor variants in the human population", + "author": "Van Tol HH, Wu CM, Guan HC, Ohara K, Bunzow JR, Civelli O, Kennedy J, Seeman P, Niznik HB, Jovanovic V", + "citation": "Van Tol HH, Wu CM, Guan HC, Ohara K, Bunzow JR, Civelli O, Kennedy J, Seeman P, Niznik HB, Jovanovic V. Multiple dopamine D4 receptor variants in the human population. Nature. 1992 Jul 9;358(6382):149-52. PubMed PMID: 1319557.", + "otherId": "0", + "citationId": 14, + "otherSource": "" + } + }, + { + "aeid": 638, + "assayComponentEndpointName": "NVS_GPCR_hETA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hETA was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hETA, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene EDNRA. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Endothelin-1", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 375, + "assayComponentName": "NVS_GPCR_hETA", + "assayComponentDesc": "NVS_GPCR_hETA is one of one assay component(s) measured or calculated from the NVS_GPCR_hETA assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Endothelin-1] are indicative of a change in receptor function and kinetics for the human endothelin receptor type A [GeneSymbol:EDNRA | GeneID:1909 | Uniprot_SwissProt_Accession:P25101].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Endothelin-1", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 189, + "assayName": "NVS_GPCR_hETA", + "assayDesc": "NVS_GPCR_hETA is a biochemical, single-readout assay that uses extracted gene-proteins from Human neuroblastoma cells (SH-SY5Y) in a cell-free assay. Measurements were taken 3 hours after chemical dosing in a 96-well plate.", + "timepointHr": 3.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "Human neuroblastoma cells (SH-SY5Y)", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 105, + "geneName": "endothelin receptor type A", + "description": null, + "geneSymbol": "EDNRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1909, + "officialSymbol": "EDNRA", + "officialFullName": "endothelin receptor type A", + "uniprotAccessionNumber": "P25101" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1700206", + "pmid": 1700206, + "title": "Tissue specificity of endothelin binding sites", + "author": "Bolger GT, Liard F, Krogsrud R, Thibeault D, Jaramillo J", + "citation": "Bolger GT, Liard F, Krogsrud R, Thibeault D, Jaramillo J. Tissue specificity of endothelin binding sites. J Cardiovasc Pharmacol. 1990 Sep;16(3):367-75. PubMed PMID: 1700206.", + "otherId": "0", + "citationId": 20, + "otherSource": "" + } + }, + { + "aeid": 639, + "assayComponentEndpointName": "NVS_GPCR_hETB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hETB was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hETB, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene EDNRB. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Endothelin-1", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 376, + "assayComponentName": "NVS_GPCR_hETB", + "assayComponentDesc": "NVS_GPCR_hETB is one of one assay component(s) measured or calculated from the NVS_GPCR_hETB assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Endothelin-1] are indicative of a change in receptor function and kinetics for the human endothelin receptor type B [GeneSymbol:EDNRB | GeneID:1910 | Uniprot_SwissProt_Accession:P24530].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Endothelin-1", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 190, + "assayName": "NVS_GPCR_hETB", + "assayDesc": "NVS_GPCR_hETB is a biochemical, single-readout assay that uses extracted gene-proteins from Human astrocytoma cells in a cell-free assay. Measurements were taken 4 hours after chemical dosing in a 96-well plate.", + "timepointHr": 4.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "Human astrocytoma cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 106, + "geneName": "endothelin receptor type B", + "description": null, + "geneSymbol": "EDNRB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1910, + "officialSymbol": "EDNRB", + "officialFullName": "endothelin receptor type B", + "uniprotAccessionNumber": "P24530" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7616437", + "pmid": 7616437, + "title": "Endothelin receptor in human astrocytoma U373MG cells: binding, dissociation, receptor internalization", + "author": "Wu-Wong JR, Chiou WJ, Magnuson SR, Opgenorth TJ", + "citation": "Wu-Wong JR, Chiou WJ, Magnuson SR, Opgenorth TJ. Endothelin receptor in human astrocytoma U373MG cells: binding, dissociation, receptor internalization. J Pharmacol Exp Ther. 1995 Jul;274(1):499-507. PubMed PMID: 7616437.", + "otherId": "0", + "citationId": 141, + "otherSource": "" + } + }, + { + "aeid": 640, + "assayComponentEndpointName": "NVS_GPCR_hH1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hH1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hH1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene HRH1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tripolidine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 377, + "assayComponentName": "NVS_GPCR_hH1", + "assayComponentDesc": "NVS_GPCR_hH1 is one of one assay component(s) measured or calculated from the NVS_GPCR_hH1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Pyrilamine] are indicative of a change in receptor function and kinetics for the human histamine receptor H1 [GeneSymbol:HRH1 | GeneID:3269 | Uniprot_SwissProt_Accession:P35367].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Pyrilamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 191, + "assayName": "NVS_GPCR_hH1", + "assayDesc": "NVS_GPCR_hH1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 160, + "geneName": "histamine receptor H1", + "description": null, + "geneSymbol": "HRH1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3269, + "officialSymbol": "HRH1", + "officialFullName": "histamine receptor H1", + "uniprotAccessionNumber": "P35367" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/448359", + "pmid": 448359, + "title": "Heterogeneity of histamine H1-receptors: species variations in [3H]mepyramine binding of brain membranes", + "author": "Chang RS, Tran VT, Snyder SH", + "citation": "Chang RS, Tran VT, Snyder SH. Heterogeneity of histamine H1-receptors: species variations in [3H]mepyramine binding of brain membranes. J Neurochem. 1979 Jun;32(6):1653-63. PubMed PMID: 448359.", + "otherId": "0", + "citationId": 8, + "otherSource": "" + } + }, + { + "aeid": 641, + "assayComponentEndpointName": "NVS_GPCR_hLTB4_BLT1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hLTB4_BLT1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hLTB4_BLT1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene LTB4R. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Leukotriene B4 (LTB4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 378, + "assayComponentName": "NVS_GPCR_hLTB4_BLT1", + "assayComponentDesc": "NVS_GPCR_hLTB4_BLT1 is one of one assay component(s) measured or calculated from the NVS_GPCR_hLTB4_BLT1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Leukotriene B4] are indicative of a change in receptor function and kinetics for the human leukotriene B4 receptor [GeneSymbol:LTB4R | GeneID:1241 | Uniprot_SwissProt_Accession:Q15722].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Leukotriene B4", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 192, + "assayName": "NVS_GPCR_hLTB4_BLT1", + "assayDesc": "NVS_GPCR_hLTB4_BLT1 is a biochemical, single-readout assay that uses extracted gene-proteins from Human neutrophils in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "Human neutrophils", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 68, + "geneName": "leukotriene B4 receptor", + "description": null, + "geneSymbol": "LTB4R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1241, + "officialSymbol": "LTB4R", + "officialFullName": "leukotriene B4 receptor", + "uniprotAccessionNumber": "Q15722" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/9177352", + "pmid": 9177352, + "title": "A G-protein-coupled receptor for leukotriene B4 that mediates chemotaxis", + "author": "Yokomizo T, Izumi T, Chang K, Takuwa Y, Shimizu T", + "citation": "Yokomizo T, Izumi T, Chang K, Takuwa Y, Shimizu T. A G-protein-coupled receptor for leukotriene B4 that mediates chemotaxis. Nature. 1997 Jun 5;387(6633):620-4. PubMed PMID: 9177352.", + "otherId": "0", + "citationId": 172, + "otherSource": "" + } + }, + { + "aeid": 642, + "assayComponentEndpointName": "NVS_GPCR_hM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hM1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hM1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene CHRM1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methylscopolamine bromide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 379, + "assayComponentName": "NVS_GPCR_hM1", + "assayComponentDesc": "NVS_GPCR_hM1 is one of one assay component(s) measured or calculated from the NVS_GPCR_hM1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-N-methylscopolamine chloride] are indicative of a change in receptor function and kinetics for the human cholinergic receptor, muscarinic 1 [GeneSymbol:CHRM1 | GeneID:1128 | Uniprot_SwissProt_Accession:P11229].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-N-methylscopolamine chloride", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 193, + "assayName": "NVS_GPCR_hM1", + "assayDesc": "NVS_GPCR_hM1 is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 61, + "geneName": "cholinergic receptor, muscarinic 1", + "description": null, + "geneSymbol": "CHRM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1128, + "officialSymbol": "CHRM1", + "officialFullName": "cholinergic receptor, muscarinic 1", + "uniprotAccessionNumber": "P11229" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2704370", + "pmid": 2704370, + "title": "Antagonist binding properties of five cloned muscarinic receptors expressed in CHO-K1 cells", + "author": "Buckley NJ, Bonner TI, Buckley CM, Brann MR", + "citation": "Buckley NJ, Bonner TI, Buckley CM, Brann MR. Antagonist binding properties of five cloned muscarinic receptors expressed in CHO-K1 cells. Mol Pharmacol. 1989 Apr;35(4):469-76. PubMed PMID: 2704370.", + "otherId": "0", + "citationId": 64, + "otherSource": "" + } + }, + { + "aeid": 643, + "assayComponentEndpointName": "NVS_GPCR_hM2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hM2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hM2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene CHRM2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methylscopolamine bromide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 380, + "assayComponentName": "NVS_GPCR_hM2", + "assayComponentDesc": "NVS_GPCR_hM2 is one of one assay component(s) measured or calculated from the NVS_GPCR_hM2 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-N-methylscopolamine chloride] are indicative of a change in receptor function and kinetics for the human cholinergic receptor, muscarinic 2 [GeneSymbol:CHRM2 | GeneID:1129 | Uniprot_SwissProt_Accession:P08172].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-N-methylscopolamine chloride", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 194, + "assayName": "NVS_GPCR_hM2", + "assayDesc": "NVS_GPCR_hM2 is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 62, + "geneName": "cholinergic receptor, muscarinic 2", + "description": null, + "geneSymbol": "CHRM2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1129, + "officialSymbol": "CHRM2", + "officialFullName": "cholinergic receptor, muscarinic 2", + "uniprotAccessionNumber": "P08172" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2704370", + "pmid": 2704370, + "title": "Antagonist binding properties of five cloned muscarinic receptors expressed in CHO-K1 cells", + "author": "Buckley NJ, Bonner TI, Buckley CM, Brann MR", + "citation": "Buckley NJ, Bonner TI, Buckley CM, Brann MR. Antagonist binding properties of five cloned muscarinic receptors expressed in CHO-K1 cells. Mol Pharmacol. 1989 Apr;35(4):469-76. PubMed PMID: 2704370.", + "otherId": "0", + "citationId": 64, + "otherSource": "" + } + }, + { + "aeid": 644, + "assayComponentEndpointName": "NVS_GPCR_hM3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hM3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hM3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene CHRM3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methylscopolamine bromide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 381, + "assayComponentName": "NVS_GPCR_hM3", + "assayComponentDesc": "NVS_GPCR_hM3 is one of one assay component(s) measured or calculated from the NVS_GPCR_hM3 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-N-methylscopolamine chloride] are indicative of a change in receptor function and kinetics for the human cholinergic receptor, muscarinic 3 [GeneSymbol:CHRM3 | GeneID:1131 | Uniprot_SwissProt_Accession:P20309].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-N-methylscopolamine chloride", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 195, + "assayName": "NVS_GPCR_hM3", + "assayDesc": "NVS_GPCR_hM3 is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 63, + "geneName": "cholinergic receptor, muscarinic 3", + "description": null, + "geneSymbol": "CHRM3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1131, + "officialSymbol": "CHRM3", + "officialFullName": "cholinergic receptor, muscarinic 3", + "uniprotAccessionNumber": "P20309" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2704370", + "pmid": 2704370, + "title": "Antagonist binding properties of five cloned muscarinic receptors expressed in CHO-K1 cells", + "author": "Buckley NJ, Bonner TI, Buckley CM, Brann MR", + "citation": "Buckley NJ, Bonner TI, Buckley CM, Brann MR. Antagonist binding properties of five cloned muscarinic receptors expressed in CHO-K1 cells. Mol Pharmacol. 1989 Apr;35(4):469-76. PubMed PMID: 2704370.", + "otherId": "0", + "citationId": 64, + "otherSource": "" + } + }, + { + "aeid": 645, + "assayComponentEndpointName": "NVS_GPCR_hM4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hM4 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hM4, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene CHRM4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methylscopolamine bromide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 382, + "assayComponentName": "NVS_GPCR_hM4", + "assayComponentDesc": "NVS_GPCR_hM4 is one of one assay component(s) measured or calculated from the NVS_GPCR_hM4 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-N-methylscopolamine chloride] are indicative of a change in receptor function and kinetics for the human cholinergic receptor, muscarinic 4 [GeneSymbol:CHRM4 | GeneID:1132 | Uniprot_SwissProt_Accession:P08173].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-N-methylscopolamine chloride", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 196, + "assayName": "NVS_GPCR_hM4", + "assayDesc": "NVS_GPCR_hM4 is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 64, + "geneName": "cholinergic receptor, muscarinic 4", + "description": null, + "geneSymbol": "CHRM4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1132, + "officialSymbol": "CHRM4", + "officialFullName": "cholinergic receptor, muscarinic 4", + "uniprotAccessionNumber": "P08173" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2704370", + "pmid": 2704370, + "title": "Antagonist binding properties of five cloned muscarinic receptors expressed in CHO-K1 cells", + "author": "Buckley NJ, Bonner TI, Buckley CM, Brann MR", + "citation": "Buckley NJ, Bonner TI, Buckley CM, Brann MR. Antagonist binding properties of five cloned muscarinic receptors expressed in CHO-K1 cells. Mol Pharmacol. 1989 Apr;35(4):469-76. PubMed PMID: 2704370.", + "otherId": "0", + "citationId": 64, + "otherSource": "" + } + }, + { + "aeid": 646, + "assayComponentEndpointName": "NVS_GPCR_hM5", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hM5 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hM5, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene CHRM5. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methylscopolamine bromide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 383, + "assayComponentName": "NVS_GPCR_hM5", + "assayComponentDesc": "NVS_GPCR_hM5 is one of one assay component(s) measured or calculated from the NVS_GPCR_hM5 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-N-methylscopolamine chloride] are indicative of a change in receptor function and kinetics for the human cholinergic receptor, muscarinic 5 [GeneSymbol:CHRM5 | GeneID:1133 | Uniprot_SwissProt_Accession:P08912].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-N-methylscopolamine chloride", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 197, + "assayName": "NVS_GPCR_hM5", + "assayDesc": "NVS_GPCR_hM5 is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 65, + "geneName": "cholinergic receptor, muscarinic 5", + "description": null, + "geneSymbol": "CHRM5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1133, + "officialSymbol": "CHRM5", + "officialFullName": "cholinergic receptor, muscarinic 5", + "uniprotAccessionNumber": "P08912" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2704370", + "pmid": 2704370, + "title": "Antagonist binding properties of five cloned muscarinic receptors expressed in CHO-K1 cells", + "author": "Buckley NJ, Bonner TI, Buckley CM, Brann MR", + "citation": "Buckley NJ, Bonner TI, Buckley CM, Brann MR. Antagonist binding properties of five cloned muscarinic receptors expressed in CHO-K1 cells. Mol Pharmacol. 1989 Apr;35(4):469-76. PubMed PMID: 2704370.", + "otherId": "0", + "citationId": 64, + "otherSource": "" + } + }, + { + "aeid": 647, + "assayComponentEndpointName": "NVS_GPCR_hNK2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hNK2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hNK2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene TACR2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Neurokinin A", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 384, + "assayComponentName": "NVS_GPCR_hNK2", + "assayComponentDesc": "NVS_GPCR_hNK2 is one of one assay component(s) measured or calculated from the NVS_GPCR_hNK2 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Neurokinin A] are indicative of a change in receptor function and kinetics for the human tachykinin receptor 2 [GeneSymbol:TACR2 | GeneID:6865 | Uniprot_SwissProt_Accession:P21452].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Neurokinin A", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 198, + "assayName": "NVS_GPCR_hNK2", + "assayDesc": "NVS_GPCR_hNK2 is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 4 hours after chemical dosing in a 96-well plate.", + "timepointHr": 4.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 309, + "geneName": "tachykinin receptor 2", + "description": null, + "geneSymbol": "TACR2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6865, + "officialSymbol": "TACR2", + "officialFullName": "tachykinin receptor 2", + "uniprotAccessionNumber": "P21452" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1718474", + "pmid": 1718474, + "title": "Pharmacology of neurokinin receptors", + "author": "Regoli D, Nantel F", + "citation": "Regoli D, Nantel F. Pharmacology of neurokinin receptors. Biopolymers. 1991 May;31(6):777-83. Review. PubMed PMID: 1718474.", + "otherId": "0", + "citationId": 22, + "otherSource": "" + } + }, + { + "aeid": 648, + "assayComponentEndpointName": "NVS_GPCR_hNPY1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hNPY1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hNPY1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene NPY1R. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "porcine neuropeptide Y", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 385, + "assayComponentName": "NVS_GPCR_hNPY1", + "assayComponentDesc": "NVS_GPCR_hNPY1 is one of one assay component(s) measured or calculated from the NVS_GPCR_hNPY1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Peptide YY] are indicative of a change in receptor function and kinetics for the human neuropeptide Y receptor Y1 [GeneSymbol:NPY1R | GeneID:4886 | Uniprot_SwissProt_Accession:P25929].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Peptide YY", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 199, + "assayName": "NVS_GPCR_hNPY1", + "assayDesc": "NVS_GPCR_hNPY1 is a biochemical, single-readout assay that uses extracted gene-proteins from SK-N-MC in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "SK-N-MC", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 219, + "geneName": "neuropeptide Y receptor Y1", + "description": null, + "geneSymbol": "NPY1R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4886, + "officialSymbol": "NPY1R", + "officialFullName": "neuropeptide Y receptor Y1", + "uniprotAccessionNumber": "P25929" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2170863", + "pmid": 2170863, + "title": "Quantitative autoradiographic distribution of [125I]Bolton-Hunter neuropeptide Y receptor binding sites in rat brain. Comparison with [125I]peptide YY receptor sites", + "author": "Martel JC, Fournier A, St Pierre S, Quirion R", + "citation": "Martel JC, Fournier A, St Pierre S, Quirion R. Quantitative autoradiographic distribution of [125I]Bolton-Hunter neuropeptide Y receptor binding sites in rat brain. Comparison with [125I]peptide YY receptor sites. Neuroscience. 1990;36(1):255-83. PubMed PMID: 2170863.", + "otherId": "0", + "citationId": 35, + "otherSource": "" + } + }, + { + "aeid": 649, + "assayComponentEndpointName": "NVS_GPCR_hNPY2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hNPY2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hNPY2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene NPY2R. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "porcine neuropeptide Y", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 386, + "assayComponentName": "NVS_GPCR_hNPY2", + "assayComponentDesc": "NVS_GPCR_hNPY2 is one of one assay component(s) measured or calculated from the NVS_GPCR_hNPY2 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Peptide YY] are indicative of a change in receptor function and kinetics for the human neuropeptide Y receptor Y2 [GeneSymbol:NPY2R | GeneID:4887 | Uniprot_SwissProt_Accession:P49146].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Peptide YY", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 200, + "assayName": "NVS_GPCR_hNPY2", + "assayDesc": "NVS_GPCR_hNPY2 is a biochemical, single-readout assay that uses extracted gene-proteins from SK-N-MC in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "SK-N-MC", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 220, + "geneName": "neuropeptide Y receptor Y2", + "description": null, + "geneSymbol": "NPY2R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4887, + "officialSymbol": "NPY2R", + "officialFullName": "neuropeptide Y receptor Y2", + "uniprotAccessionNumber": "P49146" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2170863", + "pmid": 2170863, + "title": "Quantitative autoradiographic distribution of [125I]Bolton-Hunter neuropeptide Y receptor binding sites in rat brain. Comparison with [125I]peptide YY receptor sites", + "author": "Martel JC, Fournier A, St Pierre S, Quirion R", + "citation": "Martel JC, Fournier A, St Pierre S, Quirion R. Quantitative autoradiographic distribution of [125I]Bolton-Hunter neuropeptide Y receptor binding sites in rat brain. Comparison with [125I]peptide YY receptor sites. Neuroscience. 1990;36(1):255-83. PubMed PMID: 2170863.", + "otherId": "0", + "citationId": 35, + "otherSource": "" + } + }, + { + "aeid": 650, + "assayComponentEndpointName": "NVS_GPCR_hNTS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hNTS was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hNTS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene NTSR1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "neurotensin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 387, + "assayComponentName": "NVS_GPCR_hNTS", + "assayComponentDesc": "NVS_GPCR_hNTS is one of one assay component(s) measured or calculated from the NVS_GPCR_hNTS assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-neurotensin] are indicative of a change in receptor function and kinetics for the human neurotensin receptor 1 (high affinity) [GeneSymbol:NTSR1 | GeneID:4923 | Uniprot_SwissProt_Accession:P30989].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-neurotensin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 201, + "assayName": "NVS_GPCR_hNTS", + "assayDesc": "NVS_GPCR_hNTS is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 223, + "geneName": "neurotensin receptor 1 (high affinity)", + "description": null, + "geneSymbol": "NTSR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4923, + "officialSymbol": "NTSR1", + "officialFullName": "neurotensin receptor 1 (high affinity)", + "uniprotAccessionNumber": "P30989" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/6744039", + "pmid": 6744039, + "title": "Specific binding of tritiated neurotensin to rat brain membranes: characterization and regional distribution", + "author": "Goedert M, Pittaway K, Williams BJ, Emson PC", + "citation": "Goedert M, Pittaway K, Williams BJ, Emson PC. Specific binding of tritiated neurotensin to rat brain membranes: characterization and regional distribution. Brain Res. 1984 Jun 18;304(1):71-81. PubMed PMID: 6744039.", + "otherId": "0", + "citationId": 129, + "otherSource": "" + } + }, + { + "aeid": 651, + "assayComponentEndpointName": "NVS_GPCR_hOpiate_D1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hOpiate_D1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hOpiate_D1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene OPRD1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Naltriben methanesulfonate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 388, + "assayComponentName": "NVS_GPCR_hOpiate_D1", + "assayComponentDesc": "NVS_GPCR_hOpiate_D1 is one of one assay component(s) measured or calculated from the NVS_GPCR_hOpiate_D1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Naltrindole] are indicative of a change in receptor function and kinetics for the human opioid receptor, delta 1 [GeneSymbol:OPRD1 | GeneID:4985 | Uniprot_SwissProt_Accession:P41143].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Naltrindole", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 202, + "assayName": "NVS_GPCR_hOpiate_D1", + "assayDesc": "NVS_GPCR_hOpiate_D1 is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 225, + "geneName": "opioid receptor, delta 1", + "description": null, + "geneSymbol": "OPRD1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4985, + "officialSymbol": "OPRD1", + "officialFullName": "opioid receptor, delta 1", + "uniprotAccessionNumber": "P41143" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7605911", + "pmid": 7605911, + "title": "Human delta opioid receptor: a stable cell line for functional studies of opioids", + "author": "Malatynska E, Wang Y, Knapp RJ, Santoro G, Li X, Waite S, Roeske WR, Yamamura HI", + "citation": "Malatynska E, Wang Y, Knapp RJ, Santoro G, Li X, Waite S, Roeske WR, Yamamura HI. Human delta opioid receptor: a stable cell line for functional studies of opioids. Neuroreport. 1995 Mar 7;6(4):613-6. PubMed PMID: 7605911.", + "otherId": "0", + "citationId": 140, + "otherSource": "" + } + }, + { + "aeid": 72, + "assayComponentEndpointName": "ATG_E_Box_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_E_Box_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_E_Box_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene USF1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic helix-loop-helix protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic helix-loop-helix protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 41, + "assayComponentName": "ATG_E_Box_CIS", + "assayComponentDesc": "ATG_E_Box_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene Ebox, which is responsive to the endogenous human upstream transcription factor 1 [GeneSymbol:USF1 | GeneID:7391 | Uniprot_SwissProt_Accession:P22415].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "Ebox RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 333, + "geneName": "upstream transcription factor 1", + "description": null, + "geneSymbol": "USF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7391, + "officialSymbol": "USF1", + "officialFullName": "upstream transcription factor 1", + "uniprotAccessionNumber": "P22415" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 73, + "assayComponentEndpointName": "ATG_E2F_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_E2F_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_E2F_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene E2F1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is E2F transcription factor.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "E2F transcription factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 42, + "assayComponentName": "ATG_E2F_CIS", + "assayComponentDesc": "ATG_E2F_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene E2F, which is responsive to the endogenous human E2F transcription factor 1 [GeneSymbol:E2F1 | GeneID:1869 | Uniprot_SwissProt_Accession:Q01094].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "E2F RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 104, + "geneName": "E2F transcription factor 1", + "description": null, + "geneSymbol": "E2F1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1869, + "officialSymbol": "E2F1", + "officialFullName": "E2F transcription factor 1", + "uniprotAccessionNumber": "Q01094" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 74, + "assayComponentEndpointName": "ATG_EGR_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_EGR_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_EGR_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene EGR1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is zinc finger.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "zinc finger", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 43, + "assayComponentName": "ATG_EGR_CIS", + "assayComponentDesc": "ATG_EGR_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene EGR, which is responsive to the endogenous human early growth response 1 [GeneSymbol:EGR1 | GeneID:1958 | Uniprot_SwissProt_Accession:P18146].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "EGR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 109, + "geneName": "early growth response 1", + "description": null, + "geneSymbol": "EGR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1958, + "officialSymbol": "EGR1", + "officialFullName": "early growth response 1", + "uniprotAccessionNumber": "P18146" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 75, + "assayComponentEndpointName": "ATG_ERE_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_ERE_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_ERE_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ESR1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 44, + "assayComponentName": "ATG_ERE_CIS", + "assayComponentDesc": "ATG_ERE_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element ERE, which is responsive to the endogenous human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ERE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 76, + "assayComponentEndpointName": "ATG_Ets_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_Ets_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_Ets_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ETS1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is winged helix-turn-helix.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "winged helix-turn-helix", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 45, + "assayComponentName": "ATG_Ets_CIS", + "assayComponentDesc": "ATG_Ets_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene Ets, which is responsive to the endogenous human v-ets avian erythroblastosis virus E26 oncogene homolog 1 [GeneSymbol:ETS1 | GeneID:2113 | Uniprot_SwissProt_Accession:P14921].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "Ets RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 122, + "geneName": "v-ets avian erythroblastosis virus E26 oncogene homolog 1", + "description": null, + "geneSymbol": "ETS1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2113, + "officialSymbol": "ETS1", + "officialFullName": "v-ets avian erythroblastosis virus E26 oncogene homolog 1", + "uniprotAccessionNumber": "P14921" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 77, + "assayComponentEndpointName": "ATG_FoxA2_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_FoxA2_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_FoxA2_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene FOXA2. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is forkhead box protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "forkhead box protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 46, + "assayComponentName": "ATG_FoxA2_CIS", + "assayComponentDesc": "ATG_FoxA2_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene FoxA, which is responsive to the endogenous human forkhead box A2 [GeneSymbol:FOXA2 | GeneID:3170 | Uniprot_SwissProt_Accession:Q9Y261].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "FoxA RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 156, + "geneName": "forkhead box A2", + "description": null, + "geneSymbol": "FOXA2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3170, + "officialSymbol": "FOXA2", + "officialFullName": "forkhead box A2", + "uniprotAccessionNumber": "Q9Y261" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 78, + "assayComponentEndpointName": "ATG_FoxO_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_FoxO_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_FoxO_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene FOXO1 and FOXO3. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is forkhead box protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "forkhead box protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 47, + "assayComponentName": "ATG_FoxO_CIS", + "assayComponentDesc": "ATG_FoxO_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene FoxO, which is responsive to the endogenous human forkhead box O1 and forkhead box O3 [GeneSymbol:FOXO1 & FOXO3 | GeneID:2308 & 2309 | Uniprot_SwissProt_Accession:Q12778 & O43524].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "FoxO RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 129, + "geneName": "forkhead box O1", + "description": null, + "geneSymbol": "FOXO1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2308, + "officialSymbol": "FOXO1", + "officialFullName": "forkhead box O1", + "uniprotAccessionNumber": "Q12778" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 79, + "assayComponentEndpointName": "ATG_GATA_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_GATA_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_GATA_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene GATA1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is GATA proteins.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "GATA proteins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 48, + "assayComponentName": "ATG_GATA_CIS", + "assayComponentDesc": "ATG_GATA_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene GATA, which is responsive to the endogenous human GATA binding protein 1 (globin transcription factor 1) [GeneSymbol:GATA1 | GeneID:2623 | Uniprot_SwissProt_Accession:P15976].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GATA RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 139, + "geneName": "GATA binding protein 1 (globin transcription factor 1)", + "description": null, + "geneSymbol": "GATA1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2623, + "officialSymbol": "GATA1", + "officialFullName": "GATA binding protein 1 (globin transcription factor 1)", + "uniprotAccessionNumber": "P15976" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 80, + "assayComponentEndpointName": "ATG_GLI_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_GLI_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_GLI_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene GLI1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is zinc finger.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "zinc finger", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 49, + "assayComponentName": "ATG_GLI_CIS", + "assayComponentDesc": "ATG_GLI_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene GLI, which is responsive to the endogenous human GLI family zinc finger 1 [GeneSymbol:GLI1 | GeneID:2735 | Uniprot_SwissProt_Accession:P08151].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GLI RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 144, + "geneName": "GLI family zinc finger 1", + "description": null, + "geneSymbol": "GLI1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2735, + "officialSymbol": "GLI1", + "officialFullName": "GLI family zinc finger 1", + "uniprotAccessionNumber": "P08151" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 81, + "assayComponentEndpointName": "ATG_GRE_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_GRE_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_GRE_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR3C1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Dexamethasone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 50, + "assayComponentName": "ATG_GRE_CIS", + "assayComponentDesc": "ATG_GRE_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element GRE, which is responsive to the endogenous human nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor) [GeneSymbol:NR3C1 | GeneID:2908 | Uniprot_SwissProt_Accession:P04150].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GRE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 82, + "assayComponentEndpointName": "ATG_HIF1a_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_HIF1a_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_HIF1a_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene HIF1A. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic helix-loop-helix protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic helix-loop-helix protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 51, + "assayComponentName": "ATG_HIF1a_CIS", + "assayComponentDesc": "ATG_HIF1a_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene HIF1a, which is responsive to the endogenous human hypoxia inducible factor 1, alpha subunit (basic helix-loop-helix transcription factor) [GeneSymbol:HIF1A | GeneID:3091 | Uniprot_SwissProt_Accession:Q16665].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "HIF1a RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 152, + "geneName": "hypoxia inducible factor 1, alpha subunit (basic helix-loop-helix transcription factor)", + "description": null, + "geneSymbol": "HIF1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3091, + "officialSymbol": "HIF1A", + "officialFullName": "hypoxia inducible factor 1, alpha subunit (basic helix-loop-helix transcription factor)", + "uniprotAccessionNumber": "Q16665" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 83, + "assayComponentEndpointName": "ATG_HNF6_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_HNF6_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_HNF6_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ONECUT1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is homeobox protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "homeobox protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 52, + "assayComponentName": "ATG_HNF6_CIS", + "assayComponentDesc": "ATG_HNF6_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene HNF6, which is responsive to the endogenous human one cut homeobox 1 [GeneSymbol:ONECUT1 | GeneID:3175 | Uniprot_SwissProt_Accession:Q9UBC0].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "HNF6 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 159, + "geneName": "one cut homeobox 1", + "description": null, + "geneSymbol": "ONECUT1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3175, + "officialSymbol": "ONECUT1", + "officialFullName": "one cut homeobox 1", + "uniprotAccessionNumber": "Q9UBC0" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 84, + "assayComponentEndpointName": "ATG_HSE_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_HSE_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_HSE_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene HSF1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is heat shock protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Geldanamycin", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "heat shock protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 53, + "assayComponentName": "ATG_HSE_CIS", + "assayComponentDesc": "ATG_HSE_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene HSE, which is responsive to the endogenous human heat shock transcription factor 1 [GeneSymbol:HSF1 | GeneID:3297 | Uniprot_SwissProt_Accession:Q00613].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "HSE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 161, + "geneName": "heat shock transcription factor 1", + "description": null, + "geneSymbol": "HSF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3297, + "officialSymbol": "HSF1", + "officialFullName": "heat shock transcription factor 1", + "uniprotAccessionNumber": "Q00613" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 85, + "assayComponentEndpointName": "ATG_IR1_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_IR1_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_IR1_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR1H4. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 54, + "assayComponentName": "ATG_IR1_CIS", + "assayComponentDesc": "ATG_IR1_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene IR1, which is responsive to the endogenous human nuclear receptor subfamily 1, group H, member 4 [GeneSymbol:NR1H4 | GeneID:9971 | Uniprot_SwissProt_Accession:Q96RI1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "IR1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 357, + "geneName": "nuclear receptor subfamily 1, group H, member 4", + "description": null, + "geneSymbol": "NR1H4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9971, + "officialSymbol": "NR1H4", + "officialFullName": "nuclear receptor subfamily 1, group H, member 4", + "uniprotAccessionNumber": "Q96RI1" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 86, + "assayComponentEndpointName": "ATG_ISRE_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_ISRE_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_ISRE_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene IRF1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is interferon regulatory factors.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "interferon regulatory factors", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 55, + "assayComponentName": "ATG_ISRE_CIS", + "assayComponentDesc": "ATG_ISRE_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element ISRE, which is responsive to the endogenous human interferon regulatory factor 1 [GeneSymbol:IRF1 | GeneID:3659 | Uniprot_SwissProt_Accession:P10914].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ISRE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 180, + "geneName": "interferon regulatory factor 1", + "description": null, + "geneSymbol": "IRF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3659, + "officialSymbol": "IRF1", + "officialFullName": "interferon regulatory factor 1", + "uniprotAccessionNumber": "P10914" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 87, + "assayComponentEndpointName": "ATG_M_06_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_M_06_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_M_06_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \n\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 56, + "assayComponentName": "ATG_M_06_CIS", + "assayComponentDesc": "ATG_M_06_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene M_06, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M06 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 88, + "assayComponentEndpointName": "ATG_M_19_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_M_19_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_M_19_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \n\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 57, + "assayComponentName": "ATG_M_19_CIS", + "assayComponentDesc": "ATG_M_19_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene M_19, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "M19 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 91, + "assayComponentEndpointName": "ATG_MRE_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_MRE_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_MRE_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene MTF1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is zinc finger.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "zinc finger", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 60, + "assayComponentName": "ATG_MRE_CIS", + "assayComponentDesc": "ATG_MRE_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element MRE, which is responsive to the endogenous human metal-regulatory transcription factor 1 [GeneSymbol:MTF1 | GeneID:4520 | Uniprot_SwissProt_Accession:Q14872].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "MRE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 211, + "geneName": "metal-regulatory transcription factor 1", + "description": null, + "geneSymbol": "MTF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4520, + "officialSymbol": "MTF1", + "officialFullName": "metal-regulatory transcription factor 1", + "uniprotAccessionNumber": "Q14872" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 104, + "assayComponentEndpointName": "ATG_RORE_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_RORE_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_RORE_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RORA and RORB and RORC. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 73, + "assayComponentName": "ATG_RORE_CIS", + "assayComponentDesc": "ATG_RORE_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element RORE, which is responsive to the endogenous human RAR-related orphan receptor A and RAR-related orphan receptor B and RAR-related orphan receptor C [GeneSymbol:RORA & RORB & RORC | GeneID:6095 & 6096 & 6097 | Uniprot_SwissProt_Accession:P35398 & Q92753 & P51449].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "RORE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 284, + "geneName": "RAR-related orphan receptor A", + "description": null, + "geneSymbol": "RORA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6095, + "officialSymbol": "RORA", + "officialFullName": "RAR-related orphan receptor A", + "uniprotAccessionNumber": "P35398" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 92, + "assayComponentEndpointName": "ATG_Myb_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_Myb_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_Myb_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene MYB. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is MYB proteins.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "MYB proteins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 61, + "assayComponentName": "ATG_Myb_CIS", + "assayComponentDesc": "ATG_Myb_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene Myb, which is responsive to the endogenous human v-myb avian myeloblastosis viral oncogene homolog [GeneSymbol:MYB | GeneID:4602 | Uniprot_SwissProt_Accession:P10242].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "Myb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 212, + "geneName": "v-myb avian myeloblastosis viral oncogene homolog", + "description": null, + "geneSymbol": "MYB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4602, + "officialSymbol": "MYB", + "officialFullName": "v-myb avian myeloblastosis viral oncogene homolog", + "uniprotAccessionNumber": "P10242" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 93, + "assayComponentEndpointName": "ATG_Myc_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_Myc_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_Myc_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene MYC. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic helix-loop-helix leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic helix-loop-helix leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 62, + "assayComponentName": "ATG_Myc_CIS", + "assayComponentDesc": "ATG_Myc_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene Myc, which is responsive to the endogenous human v-myc avian myelocytomatosis viral oncogene homolog [GeneSymbol:MYC | GeneID:4609 | Uniprot_SwissProt_Accession:P01106].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "Myc RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 213, + "geneName": "v-myc avian myelocytomatosis viral oncogene homolog", + "description": null, + "geneSymbol": "MYC", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4609, + "officialSymbol": "MYC", + "officialFullName": "v-myc avian myelocytomatosis viral oncogene homolog", + "uniprotAccessionNumber": "P01106" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 94, + "assayComponentEndpointName": "ATG_NF_kB_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_NF_kB_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_NF_kB_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NFKB1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is NF-kappa B.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "NF-kappa B", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 63, + "assayComponentName": "ATG_NF_kB_CIS", + "assayComponentDesc": "ATG_NF_kB_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene NF-kB, which is responsive to the endogenous human nuclear factor of kappa light polypeptide gene enhancer in B-cells 1 [GeneSymbol:NFKB1 | GeneID:4790 | Uniprot_SwissProt_Accession:P19838].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "NF-kB RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 218, + "geneName": "nuclear factor of kappa light polypeptide gene enhancer in B-cells 1", + "description": null, + "geneSymbol": "NFKB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4790, + "officialSymbol": "NFKB1", + "officialFullName": "nuclear factor of kappa light polypeptide gene enhancer in B-cells 1", + "uniprotAccessionNumber": "P19838" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 95, + "assayComponentEndpointName": "ATG_NFI_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_NFI_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_NFI_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NFIA. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is nuclear factor I.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "nuclear factor I", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 64, + "assayComponentName": "ATG_NFI_CIS", + "assayComponentDesc": "ATG_NFI_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene NFI, which is responsive to the endogenous human nuclear factor I/A [GeneSymbol:NFIA | GeneID:4774 | Uniprot_SwissProt_Accession:Q12857].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "NFI RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 216, + "geneName": "nuclear factor I/A", + "description": null, + "geneSymbol": "NFIA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4774, + "officialSymbol": "NFIA", + "officialFullName": "nuclear factor I/A", + "uniprotAccessionNumber": "Q12857" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 96, + "assayComponentEndpointName": "ATG_NRF1_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_NRF1_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_NRF1_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NRF1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is nuclear respiratory factors.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "nuclear respiratory factors", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 65, + "assayComponentName": "ATG_NRF1_CIS", + "assayComponentDesc": "ATG_NRF1_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene NRF1, which is responsive to the endogenous human nuclear respiratory factor 1 [GeneSymbol:NRF1 | GeneID:4899 | Uniprot_SwissProt_Accession:Q16656].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "NRF1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 221, + "geneName": "nuclear respiratory factor 1", + "description": null, + "geneSymbol": "NRF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4899, + "officialSymbol": "NRF1", + "officialFullName": "nuclear respiratory factor 1", + "uniprotAccessionNumber": "Q16656" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 97, + "assayComponentEndpointName": "ATG_NRF2_ARE_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_NRF2_ARE_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_NRF2_ARE_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NFE2L2. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 66, + "assayComponentName": "ATG_NRF2_ARE_CIS", + "assayComponentDesc": "ATG_NRF2_ARE_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element ARE, which is responsive to the endogenous human nuclear factor, erythroid 2-like 2 [GeneSymbol:NFE2L2 | GeneID:4780 | Uniprot_SwissProt_Accession:Q16236].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "ARE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 217, + "geneName": "nuclear factor, erythroid 2-like 2", + "description": null, + "geneSymbol": "NFE2L2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4780, + "officialSymbol": "NFE2L2", + "officialFullName": "nuclear factor, erythroid 2-like 2", + "uniprotAccessionNumber": "Q16236" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 98, + "assayComponentEndpointName": "ATG_Oct_MLP_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_Oct_MLP_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_Oct_MLP_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene POU2F1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is POU domain protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "POU domain protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 67, + "assayComponentName": "ATG_Oct_MLP_CIS", + "assayComponentDesc": "ATG_Oct_MLP_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene Oct, which is responsive to the endogenous human POU class 2 homeobox 1 [GeneSymbol:POU2F1 | GeneID:5451 | Uniprot_SwissProt_Accession:P14859].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "Oct RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 245, + "geneName": "POU class 2 homeobox 1", + "description": null, + "geneSymbol": "POU2F1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5451, + "officialSymbol": "POU2F1", + "officialFullName": "POU class 2 homeobox 1", + "uniprotAccessionNumber": "P14859" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 99, + "assayComponentEndpointName": "ATG_p53_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_p53_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_p53_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TP53. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is tumor suppressor.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "tumor suppressor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 68, + "assayComponentName": "ATG_p53_CIS", + "assayComponentDesc": "ATG_p53_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene p53, which is responsive to the endogenous human tumor protein p53 [GeneSymbol:TP53 | GeneID:7157 | Uniprot_SwissProt_Accession:P04637].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "p53 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 329, + "geneName": "tumor protein p53", + "description": null, + "geneSymbol": "TP53", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7157, + "officialSymbol": "TP53", + "officialFullName": "tumor protein p53", + "uniprotAccessionNumber": "P04637" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 652, + "assayComponentEndpointName": "NVS_GPCR_hOpiate_mu", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hOpiate_mu was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hOpiate_mu, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene OPRM1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Naloxone HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 389, + "assayComponentName": "NVS_GPCR_hOpiate_mu", + "assayComponentDesc": "NVS_GPCR_hOpiate_mu is one of one assay component(s) measured or calculated from the NVS_GPCR_hOpiate_mu assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Diprenorphine] are indicative of a change in receptor function and kinetics for the human opioid receptor, mu 1 [GeneSymbol:OPRM1 | GeneID:4988 | Uniprot_SwissProt_Accession:P35372].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Diprenorphine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 203, + "assayName": "NVS_GPCR_hOpiate_mu", + "assayDesc": "NVS_GPCR_hOpiate_mu is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 2.5 hours after chemical dosing in a 96-well plate.", + "timepointHr": 2.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 227, + "geneName": "opioid receptor, mu 1", + "description": null, + "geneSymbol": "OPRM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4988, + "officialSymbol": "OPRM1", + "officialFullName": "opioid receptor, mu 1", + "uniprotAccessionNumber": "P35372" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7605911", + "pmid": 7605911, + "title": "Human delta opioid receptor: a stable cell line for functional studies of opioids", + "author": "Malatynska E, Wang Y, Knapp RJ, Santoro G, Li X, Waite S, Roeske WR, Yamamura HI", + "citation": "Malatynska E, Wang Y, Knapp RJ, Santoro G, Li X, Waite S, Roeske WR, Yamamura HI. Human delta opioid receptor: a stable cell line for functional studies of opioids. Neuroreport. 1995 Mar 7;6(4):613-6. PubMed PMID: 7605911.", + "otherId": "0", + "citationId": 140, + "otherSource": "" + } + }, + { + "aeid": 653, + "assayComponentEndpointName": "NVS_GPCR_hORL1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hORL1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hORL1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene OPRL1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Nociceptin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 390, + "assayComponentName": "NVS_GPCR_hORL1", + "assayComponentDesc": "NVS_GPCR_hORL1 is one of one assay component(s) measured or calculated from the NVS_GPCR_hORL1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Nociceptin] are indicative of a change in receptor function and kinetics for the human opiate receptor-like 1 [GeneSymbol:OPRL1 | GeneID:4987 | Uniprot_SwissProt_Accession:P41146].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Nociceptin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 204, + "assayName": "NVS_GPCR_hORL1", + "assayDesc": "NVS_GPCR_hORL1 is a biochemical, single-readout assay that uses extracted gene-proteins from HEK293 in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "HEK293", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 226, + "geneName": "opiate receptor-like 1", + "description": null, + "geneSymbol": "OPRL1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4987, + "officialSymbol": "OPRL1", + "officialFullName": "opiate receptor-like 1", + "uniprotAccessionNumber": "P41146" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7481766", + "pmid": 7481766, + "title": "Orphanin FQ: a neuropeptide that activates an opioidlike G protein-coupled receptor", + "author": "Reinscheid RK, Nothacker HP, Bourson A, Ardati A, Henningsen RA, Bunzow JR, Grandy DK, Langen H, Monsma FJ Jr, Civelli O", + "citation": "Reinscheid RK, Nothacker HP, Bourson A, Ardati A, Henningsen RA, Bunzow JR, Grandy DK, Langen H, Monsma FJ Jr, Civelli O. Orphanin FQ: a neuropeptide that activates an opioidlike G protein-coupled receptor. Science. 1995 Nov 3;270(5237):792-4. PubMed PMID: 7481766.", + "otherId": "0", + "citationId": 138, + "otherSource": "" + } + }, + { + "aeid": 654, + "assayComponentEndpointName": "NVS_GPCR_hPY2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hPY2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hPY2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene P2RY1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "ADPbS", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 391, + "assayComponentName": "NVS_GPCR_hPY2", + "assayComponentDesc": "NVS_GPCR_hPY2 is one of one assay component(s) measured or calculated from the NVS_GPCR_hPY2 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[35S]-d-ATPaS] are indicative of a change in receptor function and kinetics for the human purinergic receptor P2Y, G-protein coupled, 1 [GeneSymbol:P2RY1 | GeneID:5028 | Uniprot_SwissProt_Accession:P47900].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[35S]-d-ATPaS", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 205, + "assayName": "NVS_GPCR_hPY2", + "assayDesc": "NVS_GPCR_hPY2 is a biochemical, single-readout assay that uses extracted gene-proteins from U937 in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "U937", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 228, + "geneName": "purinergic receptor P2Y, G-protein coupled, 1", + "description": null, + "geneSymbol": "P2RY1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5028, + "officialSymbol": "P2RY1", + "officialFullName": "purinergic receptor P2Y, G-protein coupled, 1", + "uniprotAccessionNumber": "P47900" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2495280", + "pmid": 2495280, + "title": "Guanine nucleotide-sensitive interaction of a radiolabeled agonist with a phospholipase C-linked P2y-purinergic receptor", + "author": "Cooper CL, Morris AJ, Harden TK", + "citation": "Cooper CL, Morris AJ, Harden TK. Guanine nucleotide-sensitive interaction of a radiolabeled agonist with a phospholipase C-linked P2y-purinergic receptor. J Biol Chem. 1989 Apr 15;264(11):6202-6. PubMed PMID: 2495280.", + "otherId": "0", + "citationId": 55, + "otherSource": "" + } + }, + { + "aeid": 655, + "assayComponentEndpointName": "NVS_GPCR_hTXA2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hTXA2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hTXA2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene TBXA2R. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Pinane-thromboxane A2", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 392, + "assayComponentName": "NVS_GPCR_hTXA2", + "assayComponentDesc": "NVS_GPCR_hTXA2 is one of one assay component(s) measured or calculated from the NVS_GPCR_hTXA2 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-SQ 29,548] are indicative of a change in receptor function and kinetics for the human thromboxane A2 receptor [GeneSymbol:TBXA2R | GeneID:6915 | Uniprot_SwissProt_Accession:P21731].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-SQ 29,548", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 206, + "assayName": "NVS_GPCR_hTXA2", + "assayDesc": "NVS_GPCR_hTXA2 is a biochemical, single-readout assay that uses extracted gene-proteins from Human platelets in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "Human platelets", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 310, + "geneName": "thromboxane A2 receptor", + "description": null, + "geneSymbol": "TBXA2R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6915, + "officialSymbol": "TBXA2R", + "officialFullName": "thromboxane A2 receptor", + "uniprotAccessionNumber": "P21731" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2968449", + "pmid": 2968449, + "title": "Characterization of [5,6-3H]SQ 29,548 as a high affinity radioligand, binding to thromboxane A2/prostaglandin H2-receptors in human platelets", + "author": "Hedberg A, Hall SE, Ogletree ML, Harris DN, Liu EC", + "citation": "Hedberg A, Hall SE, Ogletree ML, Harris DN, Liu EC. Characterization of [5,6-3H]SQ 29,548 as a high affinity radioligand, binding to thromboxane A2/prostaglandin H2-receptors in human platelets. J Pharmacol Exp Ther. 1988 Jun;245(3):786-92. PubMed PMID: 2968449.", + "otherId": "0", + "citationId": 80, + "otherSource": "" + } + }, + { + "aeid": 656, + "assayComponentEndpointName": "NVS_GPCR_hV1A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_hV1A was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_hV1A, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene AVPR1A. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "(Phenyl[1]ac, D-Tyr(Me)[2],Arg[6,8],Lys-NH2[9])-vasopressin;Arg8-Vasopressin (AVP)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 393, + "assayComponentName": "NVS_GPCR_hV1A", + "assayComponentDesc": "NVS_GPCR_hV1A is one of one assay component(s) measured or calculated from the NVS_GPCR_hV1A assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-(Phenylac[1], D-Tyr(Me)[2], Arg[6,8],Lys-NH2[9])-Vasopressin] are indicative of a change in receptor function and kinetics for the human arginine vasopressin receptor 1A [GeneSymbol:AVPR1A | GeneID:552 | Uniprot_SwissProt_Accession:P37288].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-(Phenylac[1], D-Tyr(Me)[2], Arg[6,8],Lys-NH2[9])-Vasopressin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 207, + "assayName": "NVS_GPCR_hV1A", + "assayDesc": "NVS_GPCR_hV1A is a biochemical, single-readout assay that uses extracted gene-proteins from Human platelets in a cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 96-well plate.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "Human platelets", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 29, + "geneName": "arginine vasopressin receptor 1A", + "description": null, + "geneSymbol": "AVPR1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 552, + "officialSymbol": "AVPR1A", + "officialFullName": "arginine vasopressin receptor 1A", + "uniprotAccessionNumber": "P37288" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/3010940", + "pmid": 3010940, + "title": "Nature and properties of human platelet vasopressin receptors", + "author": "Vittet D, Rondot A, Cantau B, Launay JM, Chevillard C", + "citation": "Vittet D, Rondot A, Cantau B, Launay JM, Chevillard C. Nature and properties of human platelet vasopressin receptors. Biochem J. 1986 Feb 1;233(3):631-6. PubMed PMID: 3010940; PubMed Central PMCID: PMC1153078.", + "otherId": "0", + "citationId": 91, + "otherSource": "" + } + }, + { + "aeid": 657, + "assayComponentEndpointName": "NVS_GPCR_mCCKAPeripheral", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_mCCKAPeripheral was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_mCCKAPeripheral, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Cckar. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Cholecystokinin 8 (CCK-8) (26-33) sulfated", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 394, + "assayComponentName": "NVS_GPCR_mCCKAPeripheral", + "assayComponentDesc": "NVS_GPCR_mCCKAPeripheral is one of one assay component(s) measured or calculated from the NVS_GPCR_mCCKAPeripheral assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-cholecystokinin] are indicative of a change in receptor function and kinetics for the house mouse cholecystokinin A receptor [GeneSymbol:Cckar | GeneID:12425 | Uniprot_SwissProt_Accession:O08786].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-cholecystokinin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 208, + "assayName": "NVS_GPCR_mCCKAPeripheral", + "assayDesc": "NVS_GPCR_mCCKAPeripheral is a biochemical, single-readout assay that uses extracted gene-proteins from Mouse pancreatic membranes in a tissue-based cell-free assay. Measurements were taken 2 hours after chemical dosing in a 96-well plate.", + "timepointHr": 2.0, + "organismId": 10090, + "organism": "mouse", + "tissue": "pancreas", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Mouse pancreatic membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 370, + "geneName": "cholecystokinin A receptor", + "description": null, + "geneSymbol": "Cckar", + "organismId": 2, + "trackStatus": "live", + "entrezGeneId": 12425, + "officialSymbol": "Cckar", + "officialFullName": "cholecystokinin A receptor", + "uniprotAccessionNumber": "O08786" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2984502", + "pmid": 2984502, + "title": "Characterization of central cholecystokinin receptors using a radioiodinated octapeptide probe", + "author": "Wennogle LP, Steel DJ, Petrack B", + "citation": "Wennogle LP, Steel DJ, Petrack B. Characterization of central cholecystokinin receptors using a radioiodinated octapeptide probe. Life Sci. 1985 Apr 15;36(15):1485-92. PubMed PMID: 2984502.", + "otherId": "0", + "citationId": 81, + "otherSource": "" + } + }, + { + "aeid": 658, + "assayComponentEndpointName": "NVS_GPCR_mCKKBCentral", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_mCKKBCentral was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_mCKKBCentral, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Cckbr. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Cholecystokinin 8 (CCK-8) (26-33) sulfated", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 395, + "assayComponentName": "NVS_GPCR_mCKKBCentral", + "assayComponentDesc": "NVS_GPCR_mCKKBCentral is one of one assay component(s) measured or calculated from the NVS_GPCR_mCKKBCentral assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-cholecystokinin] are indicative of a change in receptor function and kinetics for the house mouse cholecystokinin B receptor [GeneSymbol:Cckbr | GeneID:12426 | Uniprot_SwissProt_Accession:P56481].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-cholecystokinin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 209, + "assayName": "NVS_GPCR_mCKKBCentral", + "assayDesc": "NVS_GPCR_mCKKBCentral is a biochemical, single-readout assay that uses extracted gene-proteins from Mouse forebrain membranes in a tissue-based cell-free assay. Measurements were taken 2 hours after chemical dosing in a 96-well plate.", + "timepointHr": 2.0, + "organismId": 10090, + "organism": "mouse", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Mouse forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 371, + "geneName": "cholecystokinin B receptor", + "description": null, + "geneSymbol": "Cckbr", + "organismId": 2, + "trackStatus": "live", + "entrezGeneId": 12426, + "officialSymbol": "Cckbr", + "officialFullName": "cholecystokinin B receptor", + "uniprotAccessionNumber": "P56481" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2984502", + "pmid": 2984502, + "title": "Characterization of central cholecystokinin receptors using a radioiodinated octapeptide probe", + "author": "Wennogle LP, Steel DJ, Petrack B", + "citation": "Wennogle LP, Steel DJ, Petrack B. Characterization of central cholecystokinin receptors using a radioiodinated octapeptide probe. Life Sci. 1985 Apr 15;36(15):1485-92. PubMed PMID: 2984502.", + "otherId": "0", + "citationId": 81, + "otherSource": "" + } + }, + { + "aeid": 659, + "assayComponentEndpointName": "NVS_GPCR_p5HT2C", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_p5HT2C was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_p5HT2C, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene HTR2C. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mianserin HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 396, + "assayComponentName": "NVS_GPCR_p5HT2C", + "assayComponentDesc": "NVS_GPCR_p5HT2C is one of one assay component(s) measured or calculated from the NVS_GPCR_p5HT2C assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Mesulergine] are indicative of a change in receptor function and kinetics for the human 5-hydroxytryptamine (serotonin) receptor 2C, G protein-coupled [GeneSymbol:HTR2C | GeneID:3358 | Uniprot_SwissProt_Accession:P28335].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Mesulergine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 210, + "assayName": "NVS_GPCR_p5HT2C", + "assayDesc": "NVS_GPCR_p5HT2C is a biochemical, single-readout assay that uses extracted gene-proteins from Pig choroid plexus membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 9823, + "organism": "pig", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Pig choroid plexus membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 165, + "geneName": "5-hydroxytryptamine (serotonin) receptor 2C, G protein-coupled", + "description": null, + "geneSymbol": "HTR2C", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3358, + "officialSymbol": "HTR2C", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 2C, G protein-coupled", + "uniprotAccessionNumber": "P28335" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2935410", + "pmid": 2935410, + "title": "Molecular pharmacology of 5-HT1 and 5-HT2 recognition sites in rat and pig brain membranes: radioligand binding studies with [3H]5-HT, [3H]8-OH-DPAT, (-)[125I]iodocyanopindolol, [3H]mesulergine and [3H]ketanserin", + "author": "Hoyer D, Engel G, Kalkman HO", + "citation": "Hoyer D, Engel G, Kalkman HO. Molecular pharmacology of 5-HT1 and 5-HT2 recognition sites in rat and pig brain membranes: radioligand binding studies with [3H]5-HT, [3H]8-OH-DPAT, (-)[125I]iodocyanopindolol, [3H]mesulergine and [3H]ketanserin. Eur J Pharmacol. 1985 Nov 26;118(1-2):13-23. PubMed PMID: 2935410.", + "otherId": "0", + "citationId": 78, + "otherSource": "" + } + }, + { + "aeid": 660, + "assayComponentEndpointName": "NVS_GPCR_r5HT_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_r5HT_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_r5HT_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Htr1a. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methysergide maleate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 397, + "assayComponentName": "NVS_GPCR_r5HT_NonSelective", + "assayComponentDesc": "NVS_GPCR_r5HT_NonSelective is one of one assay component(s) measured or calculated from the NVS_GPCR_r5HT_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Lysergic acid diethylamide] are indicative of a change in receptor function and kinetics for the Norway rat 5-hydroxytryptamine (serotonin) receptor 1A, G protein-coupled [GeneSymbol:Htr1a | GeneID:24473 | Uniprot_SwissProt_Accession:P19327].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Lysergic acid diethylamide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 211, + "assayName": "NVS_GPCR_r5HT_NonSelective", + "assayDesc": "NVS_GPCR_r5HT_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 390, + "geneName": "5-hydroxytryptamine (serotonin) receptor 1A, G protein-coupled", + "description": null, + "geneSymbol": "Htr1a", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24473, + "officialSymbol": "Htr1a", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 1A, G protein-coupled", + "uniprotAccessionNumber": "P19327" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/530254", + "pmid": 530254, + "title": "Multiple serotonin receptors: differential binding of [3H]5-hydroxytryptamine, [3H]lysergic acid diethylamide and [3H]spiroperidol", + "author": "Peroutka SJ, Snyder SH", + "citation": "Peroutka SJ, Snyder SH. Multiple serotonin receptors: differential binding of [3H]5-hydroxytryptamine, [3H]lysergic acid diethylamide and [3H]spiroperidol. Mol Pharmacol. 1979 Nov;16(3):687-99. PubMed PMID: 530254.", + "otherId": "0", + "citationId": 11, + "otherSource": "" + } + }, + { + "aeid": 661, + "assayComponentEndpointName": "NVS_GPCR_r5HT1_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_r5HT1_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_r5HT1_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Htr1a. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Serotonin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 398, + "assayComponentName": "NVS_GPCR_r5HT1_NonSelective", + "assayComponentDesc": "NVS_GPCR_r5HT1_NonSelective is one of one assay component(s) measured or calculated from the NVS_GPCR_r5HT1_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Hydroxytryptamine binoxalate] are indicative of a change in receptor function and kinetics for the Norway rat 5-hydroxytryptamine (serotonin) receptor 1A, G protein-coupled [GeneSymbol:Htr1a | GeneID:24473 | Uniprot_SwissProt_Accession:P19327].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Hydroxytryptamine binoxalate", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 212, + "assayName": "NVS_GPCR_r5HT1_NonSelective", + "assayDesc": "NVS_GPCR_r5HT1_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 390, + "geneName": "5-hydroxytryptamine (serotonin) receptor 1A, G protein-coupled", + "description": null, + "geneSymbol": "Htr1a", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24473, + "officialSymbol": "Htr1a", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 1A, G protein-coupled", + "uniprotAccessionNumber": "P19327" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/530254", + "pmid": 530254, + "title": "Multiple serotonin receptors: differential binding of [3H]5-hydroxytryptamine, [3H]lysergic acid diethylamide and [3H]spiroperidol", + "author": "Peroutka SJ, Snyder SH", + "citation": "Peroutka SJ, Snyder SH. Multiple serotonin receptors: differential binding of [3H]5-hydroxytryptamine, [3H]lysergic acid diethylamide and [3H]spiroperidol. Mol Pharmacol. 1979 Nov;16(3):687-99. PubMed PMID: 530254.", + "otherId": "0", + "citationId": 11, + "otherSource": "" + } + }, + { + "aeid": 662, + "assayComponentEndpointName": "NVS_GPCR_rabPAF", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rabPAF was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rabPAF, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene PTAFR. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "C16-PAF", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 399, + "assayComponentName": "NVS_GPCR_rabPAF", + "assayComponentDesc": "NVS_GPCR_rabPAF is one of one assay component(s) measured or calculated from the NVS_GPCR_rabPAF assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [Hexadecyl-2-[3H]-acetyl-sn-glyceryl-3-phosphorylcholine] are indicative of a change in receptor function and kinetics for the rabbit platelet-activating factor receptor [GeneSymbol:PTAFR | GeneID:100354046 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "Hexadecyl-2-[3H]-acetyl-sn-glyceryl-3-phosphorylcholine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 213, + "assayName": "NVS_GPCR_rabPAF", + "assayDesc": "NVS_GPCR_rabPAF is a biochemical, single-readout assay that uses extracted gene-proteins from Rabbit platelets in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 9986, + "organism": "rabbit", + "tissue": "vascular", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rabbit platelets", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 475, + "geneName": "platelet-activating factor receptor", + "description": "model", + "geneSymbol": "PTAFR", + "organismId": 9, + "trackStatus": "live", + "entrezGeneId": 100354046, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2999126", + "pmid": 2999126, + "title": "Trans-2,5-Bis-(3,4,5-trimethoxyphenyl)tetrahydrofuran. An orally active specific and competitive receptor antagonist of platelet activating factor", + "author": "Hwang SB, Lam MH, Biftu T, Beattie TR, Shen TY", + "citation": "Hwang SB, Lam MH, Biftu T, Beattie TR, Shen TY. Trans-2,5-Bis-(3,4,5-trimethoxyphenyl)tetrahydrofuran. An orally active specific and competitive receptor antagonist of platelet activating factor. J Biol Chem. 1985 Dec 15;260(29):15639-45. PubMed PMID: 2999126.", + "otherId": "0", + "citationId": 84, + "otherSource": "" + } + }, + { + "aeid": 663, + "assayComponentEndpointName": "NVS_GPCR_rAdra1_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rAdra1_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rAdra1_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Adra1a. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Phentolamine mesylate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 400, + "assayComponentName": "NVS_GPCR_rAdra1_NonSelective", + "assayComponentDesc": "NVS_GPCR_rAdra1_NonSelective is one of one assay component(s) measured or calculated from the NVS_GPCR_rAdra1_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-7-Methoxy-Prazosin] are indicative of a change in receptor function and kinetics for the Norway rat adrenoceptor alpha 1A [GeneSymbol:Adra1a | GeneID:29412 | Uniprot_SwissProt_Accession:P43140].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-7-Methoxy-Prazosin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 214, + "assayName": "NVS_GPCR_rAdra1_NonSelective", + "assayDesc": "NVS_GPCR_rAdra1_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 419, + "geneName": "adrenoceptor alpha 1A", + "description": null, + "geneSymbol": "Adra1a", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 29412, + "officialSymbol": "Adra1a", + "officialFullName": "adrenoceptor alpha 1A", + "uniprotAccessionNumber": "P43140" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2879884", + "pmid": 2879884, + "title": "Alpha-1 and alpha-2 adrenoceptor binding in cerebral cortex: competition studies with [3H]prazosin and [3H]idazoxan", + "author": "Reader TA, Brière R, Grondin L", + "citation": "Reader TA, Brière R, Grondin L. Alpha-1 and alpha-2 adrenoceptor binding in cerebral cortex: competition studies with [3H]prazosin and [3H]idazoxan. J Neural Transm. 1987;68(1-2):79-95. PubMed PMID: 2879884.", + "otherId": "0", + "citationId": 73, + "otherSource": "" + } + }, + { + "aeid": 100, + "assayComponentEndpointName": "ATG_Pax6_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_Pax6_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_Pax6_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PAX6. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is paired box protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "paired box protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 69, + "assayComponentName": "ATG_Pax6_CIS", + "assayComponentDesc": "ATG_Pax6_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene Pax, which is responsive to the endogenous human paired box 6 [GeneSymbol:PAX6 | GeneID:5080 | Uniprot_SwissProt_Accession:P26367].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "Pax RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 231, + "geneName": "paired box 6", + "description": null, + "geneSymbol": "PAX6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5080, + "officialSymbol": "PAX6", + "officialFullName": "paired box 6", + "uniprotAccessionNumber": "P26367" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 101, + "assayComponentEndpointName": "ATG_PBREM_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_PBREM_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_PBREM_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR1I3. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 70, + "assayComponentName": "ATG_PBREM_CIS", + "assayComponentDesc": "ATG_PBREM_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene PBREM, which is responsive to the endogenous human nuclear receptor subfamily 1, group I, member 3 [GeneSymbol:NR1I3 | GeneID:9970 | Uniprot_SwissProt_Accession:Q14994].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "PBREM RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 356, + "geneName": "nuclear receptor subfamily 1, group I, member 3", + "description": null, + "geneSymbol": "NR1I3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9970, + "officialSymbol": "NR1I3", + "officialFullName": "nuclear receptor subfamily 1, group I, member 3", + "uniprotAccessionNumber": "Q14994" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 102, + "assayComponentEndpointName": "ATG_PPRE_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_PPRE_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_PPRE_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARA and PPARD and PPARG. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Rosiglitazone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 71, + "assayComponentName": "ATG_PPRE_CIS", + "assayComponentDesc": "ATG_PPRE_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element PPRE, which is responsive to the endogenous human peroxisome proliferator-activated receptor alpha and peroxisome proliferator-activated receptor delta and peroxisome proliferator-activated receptor gamma [GeneSymbol:PPARA & PPARD & PPARG | GeneID:5465 & 5467 & 5468 | Uniprot_SwissProt_Accession:Q07869 & Q03181 & P37231].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "PPRE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 248, + "geneName": "peroxisome proliferator-activated receptor alpha", + "description": null, + "geneSymbol": "PPARA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5465, + "officialSymbol": "PPARA", + "officialFullName": "peroxisome proliferator-activated receptor alpha", + "uniprotAccessionNumber": "Q07869" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 103, + "assayComponentEndpointName": "ATG_PXRE_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_PXRE_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_PXRE_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR1I2. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Rifampicin", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 72, + "assayComponentName": "ATG_PXRE_CIS", + "assayComponentDesc": "ATG_PXRE_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element PXRE, which is responsive to the endogenous human nuclear receptor subfamily 1, group I, member 2 [GeneSymbol:NR1I2 | GeneID:8856 | Uniprot_SwissProt_Accession:O75469].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "PXRE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 350, + "geneName": "nuclear receptor subfamily 1, group I, member 2", + "description": null, + "geneSymbol": "NR1I2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8856, + "officialSymbol": "NR1I2", + "officialFullName": "nuclear receptor subfamily 1, group I, member 2", + "uniprotAccessionNumber": "O75469" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 105, + "assayComponentEndpointName": "ATG_Sox_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_Sox_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_Sox_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene SOX1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is HMG box protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "HMG box protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 74, + "assayComponentName": "ATG_Sox_CIS", + "assayComponentDesc": "ATG_Sox_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene SOX, which is responsive to the endogenous human SRY (sex determining region Y)-box 1 [GeneSymbol:SOX1 | GeneID:6656 | Uniprot_SwissProt_Accession:O00570].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "SOX RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 301, + "geneName": "SRY (sex determining region Y)-box 1", + "description": null, + "geneSymbol": "SOX1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6656, + "officialSymbol": "SOX1", + "officialFullName": "SRY (sex determining region Y)-box 1", + "uniprotAccessionNumber": "O00570" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 106, + "assayComponentEndpointName": "ATG_Sp1_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_Sp1_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_Sp1_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene SP1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is zinc finger.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "zinc finger", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 75, + "assayComponentName": "ATG_Sp1_CIS", + "assayComponentDesc": "ATG_Sp1_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene Sp1, which is responsive to the endogenous human Sp1 transcription factor [GeneSymbol:SP1 | GeneID:6667 | Uniprot_SwissProt_Accession:P08047].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "Sp1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 302, + "geneName": "Sp1 transcription factor", + "description": null, + "geneSymbol": "SP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6667, + "officialSymbol": "SP1", + "officialFullName": "Sp1 transcription factor", + "uniprotAccessionNumber": "P08047" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 107, + "assayComponentEndpointName": "ATG_SREBP_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_SREBP_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_SREBP_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene SREBF1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic helix-loop-helix leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic helix-loop-helix leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 76, + "assayComponentName": "ATG_SREBP_CIS", + "assayComponentDesc": "ATG_SREBP_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene SREBP, which is responsive to the endogenous human sterol regulatory element binding transcription factor 1 [GeneSymbol:SREBF1 | GeneID:6720 | Uniprot_SwissProt_Accession:P36956].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "SREBP RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 304, + "geneName": "sterol regulatory element binding transcription factor 1", + "description": null, + "geneSymbol": "SREBF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6720, + "officialSymbol": "SREBF1", + "officialFullName": "sterol regulatory element binding transcription factor 1", + "uniprotAccessionNumber": "P36956" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 108, + "assayComponentEndpointName": "ATG_STAT3_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_STAT3_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_STAT3_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene STAT3. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is stat protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "stat protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 77, + "assayComponentName": "ATG_STAT3_CIS", + "assayComponentDesc": "ATG_STAT3_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene STAT, which is responsive to the endogenous human signal transducer and activator of transcription 3 (acute-phase response factor) [GeneSymbol:STAT3 | GeneID:6774 | Uniprot_SwissProt_Accession:P40763].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "STAT RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 305, + "geneName": "signal transducer and activator of transcription 3 (acute-phase response factor)", + "description": null, + "geneSymbol": "STAT3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6774, + "officialSymbol": "STAT3", + "officialFullName": "signal transducer and activator of transcription 3 (acute-phase response factor)", + "uniprotAccessionNumber": "P40763" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 109, + "assayComponentEndpointName": "ATG_TA_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_TA_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_TA_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \n\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 78, + "assayComponentName": "ATG_TA_CIS", + "assayComponentDesc": "ATG_TA_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene TA, which is used as a basal promoter.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "TA RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 110, + "assayComponentEndpointName": "ATG_TAL_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_TAL_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_TAL_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \n\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 79, + "assayComponentName": "ATG_TAL_CIS", + "assayComponentDesc": "ATG_TAL_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene TAL, which is used as a basal promoter.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "TAL RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 111, + "assayComponentEndpointName": "ATG_TCF_b_cat_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_TCF_b_cat_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_TCF_b_cat_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TCF7 and TCF7L2 and LEF1 and TCF7L1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is HMG box protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "HMG box protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 80, + "assayComponentName": "ATG_TCF_b_cat_CIS", + "assayComponentDesc": "ATG_TCF_b_cat_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene TCF/b-cat, which is responsive to the endogenous human transcription factor 7 (T-cell specific, HMG-box) and transcription factor 7-like 2 (T-cell specific, HMG-box) and lymphoid enhancer-binding factor 1 and transcription factor 7-like 1 (T-cell specific, HMG-box) [GeneSymbol:TCF7 & TCF7L2 & LEF1 & TCF7L1 | GeneID:6932 & 6934 & 51176 & 83439 | Uniprot_SwissProt_Accession:P36402 & Q9NQB0 & Q9UJU2 & Q9HCS4].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "TCF/b-cat RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 311, + "geneName": "transcription factor 7 (T-cell specific, HMG-box)", + "description": null, + "geneSymbol": "TCF7", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6932, + "officialSymbol": "TCF7", + "officialFullName": "transcription factor 7 (T-cell specific, HMG-box)", + "uniprotAccessionNumber": "P36402" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 112, + "assayComponentEndpointName": "ATG_TGFb_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_TGFb_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_TGFb_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene TGFB1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the growth factor intended target family, where the subfamily is transforming growth factor beta.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "growth factor", + "intendedTargetFamilySub": "transforming growth factor beta", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 81, + "assayComponentName": "ATG_TGFb_CIS", + "assayComponentDesc": "ATG_TGFb_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene TGF, which is responsive to the endogenous human transforming growth factor, beta 1 [GeneSymbol:TGFB1 | GeneID:7040 | Uniprot_SwissProt_Accession:P01137].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "TGF RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 319, + "geneName": "transforming growth factor, beta 1", + "description": null, + "geneSymbol": "TGFB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7040, + "officialSymbol": "TGFB1", + "officialFullName": "transforming growth factor, beta 1", + "uniprotAccessionNumber": "P01137" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 178, + "assayComponentEndpointName": "BSK_4H_SRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_4H_SRB was analyzed into 1 assay endpoint. This assay endpoint, BSK_4H_SRB, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is cell conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 130, + "assayComponentName": "BSK_4H_SRB", + "assayComponentDesc": "BSK_4H_SRB is an assay component measured in the BSK_4H assay. It measures 0.1% sulforhodamine related to cell death using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "SRB in the 4H system is a measure of the total protein content of venular endothelial cells. Cell viability of adherent cells is measured by Sulforhodamine B (SRB) staining, a method that determines cell density by measuring total protein content of test wells.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 8, + "assayName": "BSK_4H", + "assayDesc": "BSK_4H is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 664, + "assayComponentEndpointName": "NVS_GPCR_rAdra1A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rAdra1A was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rAdra1A, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Adra1a. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Phentolamine mesylate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 401, + "assayComponentName": "NVS_GPCR_rAdra1A", + "assayComponentDesc": "NVS_GPCR_rAdra1A is one of one assay component(s) measured or calculated from the NVS_GPCR_rAdra1A assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Prazosin] are indicative of a change in receptor function and kinetics for the Norway rat adrenoceptor alpha 1A [GeneSymbol:Adra1a | GeneID:29412 | Uniprot_SwissProt_Accession:P43140].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Prazosin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 215, + "assayName": "NVS_GPCR_rAdra1A", + "assayDesc": "NVS_GPCR_rAdra1A is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes (pretreated with chlorethyl clonidine-CEC) in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes (pretreated with chlorethyl clonidine-CEC)", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 419, + "geneName": "adrenoceptor alpha 1A", + "description": null, + "geneSymbol": "Adra1a", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 29412, + "officialSymbol": "Adra1a", + "officialFullName": "adrenoceptor alpha 1A", + "uniprotAccessionNumber": "P43140" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2569345", + "pmid": 2569345, + "title": "Subclassification of alpha 1-adrenoceptor recognition sites by urapidil derivatives and other selective antagonists", + "author": "Hanft G, Gross G", + "citation": "Hanft G, Gross G. Subclassification of alpha 1-adrenoceptor recognition sites by urapidil derivatives and other selective antagonists. Br J Pharmacol. 1989 Jul;97(3):691-700. PubMed PMID: 2569345; PubMed Central PMCID: PMC1854578.", + "otherId": "0", + "citationId": 61, + "otherSource": "" + } + }, + { + "aeid": 665, + "assayComponentEndpointName": "NVS_GPCR_rAdra1B", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rAdra1B was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rAdra1B, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Adra1b. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Phentolamine mesylate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 402, + "assayComponentName": "NVS_GPCR_rAdra1B", + "assayComponentDesc": "NVS_GPCR_rAdra1B is one of one assay component(s) measured or calculated from the NVS_GPCR_rAdra1B assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-7-Methoxy-Prazosin] are indicative of a change in receptor function and kinetics for the Norway rat adrenoceptor alpha 1B [GeneSymbol:Adra1b | GeneID:24173 | Uniprot_SwissProt_Accession:P15823].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-7-Methoxy-Prazosin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 216, + "assayName": "NVS_GPCR_rAdra1B", + "assayDesc": "NVS_GPCR_rAdra1B is a biochemical, single-readout assay that uses extracted gene-proteins from Rat liver membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "liver", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat liver membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 379, + "geneName": "adrenoceptor alpha 1B", + "description": null, + "geneSymbol": "Adra1b", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24173, + "officialSymbol": "Adra1b", + "officialFullName": "adrenoceptor alpha 1B", + "uniprotAccessionNumber": "P15823" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2569345", + "pmid": 2569345, + "title": "Subclassification of alpha 1-adrenoceptor recognition sites by urapidil derivatives and other selective antagonists", + "author": "Hanft G, Gross G", + "citation": "Hanft G, Gross G. Subclassification of alpha 1-adrenoceptor recognition sites by urapidil derivatives and other selective antagonists. Br J Pharmacol. 1989 Jul;97(3):691-700. PubMed PMID: 2569345; PubMed Central PMCID: PMC1854578.", + "otherId": "0", + "citationId": 61, + "otherSource": "" + } + }, + { + "aeid": 666, + "assayComponentEndpointName": "NVS_GPCR_rAdra2_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rAdra2_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rAdra2_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Adra2a. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Phentolamine mesylate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 403, + "assayComponentName": "NVS_GPCR_rAdra2_NonSelective", + "assayComponentDesc": "NVS_GPCR_rAdra2_NonSelective is one of one assay component(s) measured or calculated from the NVS_GPCR_rAdra2_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-RX 821002] are indicative of a change in receptor function and kinetics for the Norway rat adrenoceptor alpha 2A [GeneSymbol:Adra2a | GeneID:25083 | Uniprot_SwissProt_Accession:P22909].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-RX 821002", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 217, + "assayName": "NVS_GPCR_rAdra2_NonSelective", + "assayDesc": "NVS_GPCR_rAdra2_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes in a tissue-based cell-free assay. Measurements were taken 1.25 hours after chemical dosing in a 48-well plate.", + "timepointHr": 1.25, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 402, + "geneName": "adrenoceptor alpha 2A", + "description": null, + "geneSymbol": "Adra2a", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25083, + "officialSymbol": "Adra2a", + "officialFullName": "adrenoceptor alpha 2A", + "uniprotAccessionNumber": "P22909" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2879884", + "pmid": 2879884, + "title": "Alpha-1 and alpha-2 adrenoceptor binding in cerebral cortex: competition studies with [3H]prazosin and [3H]idazoxan", + "author": "Reader TA, Brière R, Grondin L", + "citation": "Reader TA, Brière R, Grondin L. Alpha-1 and alpha-2 adrenoceptor binding in cerebral cortex: competition studies with [3H]prazosin and [3H]idazoxan. J Neural Transm. 1987;68(1-2):79-95. PubMed PMID: 2879884.", + "otherId": "0", + "citationId": 73, + "otherSource": "" + } + }, + { + "aeid": 667, + "assayComponentEndpointName": "NVS_GPCR_rAdrb_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rAdrb_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rAdrb_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Adrb1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Alprenolol HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 404, + "assayComponentName": "NVS_GPCR_rAdrb_NonSelective", + "assayComponentDesc": "NVS_GPCR_rAdrb_NonSelective is one of one assay component(s) measured or calculated from the NVS_GPCR_rAdrb_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-DHA] are indicative of a change in receptor function and kinetics for the Norway rat adrenoceptor beta 1 [GeneSymbol:Adrb1 | GeneID:24925 | Uniprot_SwissProt_Accession:P18090].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-DHA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 218, + "assayName": "NVS_GPCR_rAdrb_NonSelective", + "assayDesc": "NVS_GPCR_rAdrb_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 398, + "geneName": "adrenoceptor beta 1", + "description": null, + "geneSymbol": "Adrb1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24925, + "officialSymbol": "Adrb1", + "officialFullName": "adrenoceptor beta 1", + "uniprotAccessionNumber": "P18090" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2163719", + "pmid": 2163719, + "title": "Demonstration of high- and low-affinity beta-adrenergic receptors in slide-mounted sections of rat and human brain", + "author": "Arango V, Ernsberger P, Reis DJ, Mann JJ", + "citation": "Arango V, Ernsberger P, Reis DJ, Mann JJ. Demonstration of high- and low-affinity beta-adrenergic receptors in slide-mounted sections of rat and human brain. Brain Res. 1990 May 14;516(1):113-21. PubMed PMID: 2163719.", + "otherId": "0", + "citationId": 31, + "otherSource": "" + } + }, + { + "aeid": 668, + "assayComponentEndpointName": "NVS_GPCR_rCRF", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rCRF was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rCRF, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Crhr1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is secretin receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tyr0-oCRF", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "secretin receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 405, + "assayComponentName": "NVS_GPCR_rCRF", + "assayComponentDesc": "NVS_GPCR_rCRF is one of one assay component(s) measured or calculated from the NVS_GPCR_rCRF assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Tyr-oCRF] are indicative of a change in receptor function and kinetics for the Norway rat corticotropin releasing hormone receptor 1 [GeneSymbol:Crhr1 | GeneID:58959 | Uniprot_SwissProt_Accession:P35353].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Tyr-oCRF", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 219, + "assayName": "NVS_GPCR_rCRF", + "assayDesc": "NVS_GPCR_rCRF is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes in a tissue-based cell-free assay. Measurements were taken 2 hours after chemical dosing in a 96-well plate.", + "timepointHr": 2.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 431, + "geneName": "corticotropin releasing hormone receptor 1", + "description": null, + "geneSymbol": "Crhr1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 58959, + "officialSymbol": "Crhr1", + "officialFullName": "corticotropin releasing hormone receptor 1", + "uniprotAccessionNumber": "P35353" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/3001239", + "pmid": 3001239, + "title": "Corticotropin-releasing factor receptors are widely distributed within the rat central nervous system: an autoradiographic study", + "author": "De Souza EB, Insel TR, Perrin MH, Rivier J, Vale WW, Kuhar MJ", + "citation": "De Souza EB, Insel TR, Perrin MH, Rivier J, Vale WW, Kuhar MJ. Corticotropin-releasing factor receptors are widely distributed within the rat central nervous system: an autoradiographic study. J Neurosci. 1985\nDec;5(12):3189-203. PubMed PMID: 3001239.", + "otherId": "0", + "citationId": 86, + "otherSource": "" + } + }, + { + "aeid": 669, + "assayComponentEndpointName": "NVS_GPCR_rGABBR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rGABBR was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rGABBR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Gabbr1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is metabotropic glutamate receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "(+/-)-Baclofen", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "metabotropic glutamate receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 406, + "assayComponentName": "NVS_GPCR_rGABBR", + "assayComponentDesc": "NVS_GPCR_rGABBR is one of one assay component(s) measured or calculated from the NVS_GPCR_rGABBR assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-CGP 54626A] are indicative of a change in receptor function and kinetics for the Norway rat gamma-aminobutyric acid (GABA) B receptor 1 [GeneSymbol:Gabbr1 | GeneID:81657 | Uniprot_SwissProt_Accession:Q9Z0U4].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-CGP 54626A", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 220, + "assayName": "NVS_GPCR_rGABBR", + "assayDesc": "NVS_GPCR_rGABBR is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 437, + "geneName": "gamma-aminobutyric acid (GABA) B receptor 1", + "description": null, + "geneSymbol": "Gabbr1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 81657, + "officialSymbol": "Gabbr1", + "officialFullName": "gamma-aminobutyric acid (GABA) B receptor 1", + "uniprotAccessionNumber": "Q9Z0U4" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2850843", + "pmid": 2850843, + "title": "Evidence for pharmacologically distinct subsets of GABAB receptors", + "author": "Scherer RW, Ferkany JW, Enna SJ", + "citation": "Scherer RW, Ferkany JW, Enna SJ. Evidence for pharmacologically distinct subsets of GABAB receptors. Brain Res Bull. 1988 Sep;21(3):439-43. PubMed PMID: 2850843.", + "otherId": "0", + "citationId": 70, + "otherSource": "" + } + }, + { + "aeid": 670, + "assayComponentEndpointName": "NVS_GPCR_rGalanin", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rGalanin was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rGalanin, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Galr1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "porcine Galanin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 407, + "assayComponentName": "NVS_GPCR_rGalanin", + "assayComponentDesc": "NVS_GPCR_rGalanin is one of one assay component(s) measured or calculated from the NVS_GPCR_rGalanin assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Galanin] are indicative of a change in receptor function and kinetics for the Norway rat galanin receptor 1 [GeneSymbol:Galr1 | GeneID:50577 | Uniprot_SwissProt_Accession:Q62805].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Galanin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 221, + "assayName": "NVS_GPCR_rGalanin", + "assayDesc": "NVS_GPCR_rGalanin is a biochemical, single-readout assay that uses extracted gene-proteins from Rat brain membranes in a tissue-based cell-free assay. Measurements were taken 2 hours after chemical dosing in a 96-well plate.", + "timepointHr": 2.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat brain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 423, + "geneName": "galanin receptor 1", + "description": null, + "geneSymbol": "Galr1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 50577, + "officialSymbol": "Galr1", + "officialFullName": "galanin receptor 1", + "uniprotAccessionNumber": "Q62805" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2436195", + "pmid": 2436195, + "title": "Autoradiographic distribution of 125I-galanin binding sites in the rat central nervous system", + "author": "Skofitsch G, Sills MA, Jacobowitz DM", + "citation": "Skofitsch G, Sills MA, Jacobowitz DM. Autoradiographic distribution of 125I-galanin binding sites in the rat central nervous system. Peptides. 1986 Nov-Dec;7(6):1029-42. PubMed PMID: 2436195.", + "otherId": "0", + "citationId": 51, + "otherSource": "" + } + }, + { + "aeid": 671, + "assayComponentEndpointName": "NVS_GPCR_rGHB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rGHB was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rGHB, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Tspan17. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is metabotropic glutamate receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "NCS-382", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "metabotropic glutamate receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 408, + "assayComponentName": "NVS_GPCR_rGHB", + "assayComponentDesc": "NVS_GPCR_rGHB is one of one assay component(s) measured or calculated from the NVS_GPCR_rGHB assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-NCS-382] are indicative of a change in receptor function and kinetics for the Norway rat tetraspanin 17 [GeneSymbol:Tspan17 | GeneID:306771 | Uniprot_SwissProt_Accession:Q4V8E0].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-NCS-382", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 222, + "assayName": "NVS_GPCR_rGHB", + "assayDesc": "NVS_GPCR_rGHB is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 454, + "geneName": "tetraspanin 17", + "description": null, + "geneSymbol": "Tspan17", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 306771, + "officialSymbol": "Tspan17", + "officialFullName": "tetraspanin 17", + "uniprotAccessionNumber": "Q4V8E0" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/10869864", + "pmid": 10869864, + "title": "Design and structure-activity relationship analysis of ligands of gamma-hydroxybutyric acid receptors", + "author": "Bourguignon JJ, Schmitt M, Didier B", + "citation": "Bourguignon JJ, Schmitt M, Didier B. Design and structure-activity relationship analysis of ligands of gamma-hydroxybutyric acid receptors. Alcohol. 2000 Apr;20(3):227-36. Review. PubMed PMID: 10869864.", + "otherId": "0", + "citationId": 182, + "otherSource": "" + } + }, + { + "aeid": 672, + "assayComponentEndpointName": "NVS_GPCR_rH3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rH3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rH3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Hrh3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "N-a-methylhistamine (NAMH)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 409, + "assayComponentName": "NVS_GPCR_rH3", + "assayComponentDesc": "NVS_GPCR_rH3 is one of one assay component(s) measured or calculated from the NVS_GPCR_rH3 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-N-methylhistamine] are indicative of a change in receptor function and kinetics for the Norway rat histamine receptor H3 [GeneSymbol:Hrh3 | GeneID:85268 | Uniprot_SwissProt_Accession:Q9QYN8].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-N-methylhistamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 223, + "assayName": "NVS_GPCR_rH3", + "assayDesc": "NVS_GPCR_rH3 is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 442, + "geneName": "histamine receptor H3", + "description": null, + "geneSymbol": "Hrh3", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 85268, + "officialSymbol": "Hrh3", + "officialFullName": "histamine receptor H3", + "uniprotAccessionNumber": "Q9QYN8" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2172771", + "pmid": 2172771, + "title": "Identification of two H3-histamine receptor subtypes", + "author": "West RE Jr, Zweig A, Shih NY, Siegel MI, Egan RW, Clark MA", + "citation": "West RE Jr, Zweig A, Shih NY, Siegel MI, Egan RW, Clark MA. Identification of two H3-histamine receptor subtypes. Mol Pharmacol. 1990 Nov;38(5):610-3. PubMed PMID: 2172771.", + "otherId": "0", + "citationId": 37, + "otherSource": "" + } + }, + { + "aeid": 673, + "assayComponentEndpointName": "NVS_GPCR_rmAdra2B", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rmAdra2B was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rmAdra2B, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Adra2b. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Oxymetazoline HCl;Norepinephrine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 410, + "assayComponentName": "NVS_GPCR_rmAdra2B", + "assayComponentDesc": "NVS_GPCR_rmAdra2B is one of one assay component(s) measured or calculated from the NVS_GPCR_rmAdra2B assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-MK-912] are indicative of a change in receptor function and kinetics for the Norway rat adrenoceptor alpha 2B [GeneSymbol:Adra2b | GeneID:24174 | Uniprot_SwissProt_Accession:P19328].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-MK-912", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 224, + "assayName": "NVS_GPCR_rmAdra2B", + "assayDesc": "NVS_GPCR_rmAdra2B is a biochemical, single-readout assay that uses extracted gene-proteins from neuroglioma/blastoma hybrid cells in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "neuroglioma/blastoma hybrid cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 380, + "geneName": "adrenoceptor alpha 2B", + "description": null, + "geneSymbol": "Adra2b", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24174, + "officialSymbol": "Adra2b", + "officialFullName": "adrenoceptor alpha 2B", + "uniprotAccessionNumber": "P19328" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2564617", + "pmid": 2564617, + "title": "[3H]L-657,743 (MK-912): a new, high affinity, selective radioligand for brain alpha 2-adrenoceptors", + "author": "Pettibone DJ, Flagg SD, Totaro JA, Clineschmidt BV, Huff JR, Young SD, Chen R", + "citation": "Pettibone DJ, Flagg SD, Totaro JA, Clineschmidt BV, Huff JR, Young SD, Chen R. [3H]L-657,743 (MK-912): a new, high affinity, selective radioligand for brain alpha 2-adrenoceptors. Life Sci. 1989;44(7):459-67. PubMed PMID: 2564617.", + "otherId": "0", + "citationId": 60, + "otherSource": "" + } + }, + { + "aeid": 674, + "assayComponentEndpointName": "NVS_GPCR_rmMGluR1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rmMGluR1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rmMGluR1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Grm1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is metabotropic glutamate receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "L-Glutamate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "metabotropic glutamate receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 411, + "assayComponentName": "NVS_GPCR_rmMGluR1", + "assayComponentDesc": "NVS_GPCR_rmMGluR1 is one of one assay component(s) measured or calculated from the NVS_GPCR_rmMGluR1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Quisqualic acid] are indicative of a change in receptor function and kinetics for the Norway rat glutamate receptor, metabotropic 1 [GeneSymbol:Grm1 | GeneID:24414 | Uniprot_SwissProt_Accession:P23385].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Quisqualic acid", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 225, + "assayName": "NVS_GPCR_rmMGluR1", + "assayDesc": "NVS_GPCR_rmMGluR1 is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cerebellum in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cerebellum", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 388, + "geneName": "glutamate receptor, metabotropic 1", + "description": null, + "geneSymbol": "Grm1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24414, + "officialSymbol": "Grm1", + "officialFullName": "glutamate receptor, metabotropic 1", + "uniprotAccessionNumber": "P23385" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/11814808", + "pmid": 11814808, + "title": "[(3)H]-M-MPEP, a potent, subtype-selective radioligand for the metabotropic glutamate receptor subtype 5", + "author": "Gasparini F, Andres H, Flor PJ, Heinrich M, Inderbitzin W, Lingenhöhl K, Müller H, Munk VC, Omilusik K, Stierlin C, Stoehr N, Vranesic I, Kuhn R", + "citation": "Gasparini F, Andres H, Flor PJ, Heinrich M, Inderbitzin W, Lingenhöhl K, Müller H, Munk VC, Omilusik K, Stierlin C, Stoehr N, Vranesic I, Kuhn R. [(3)H]-M-MPEP, a potent, subtype-selective radioligand for the metabotropic glutamate receptor subtype 5. Bioorg Med Chem Lett. 2002 Feb 11;12(3):407-9. PubMed PMID: 11814808.", + "otherId": "0", + "citationId": 186, + "otherSource": "" + } + }, + { + "aeid": 675, + "assayComponentEndpointName": "NVS_GPCR_rmMGluR5", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rmMGluR5 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rmMGluR5, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Grm5. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is metabotropic glutamate receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "MPEP", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "metabotropic glutamate receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 412, + "assayComponentName": "NVS_GPCR_rmMGluR5", + "assayComponentDesc": "NVS_GPCR_rmMGluR5 is one of one assay component(s) measured or calculated from the NVS_GPCR_rmMGluR5 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-2-Methyl-6-phenylethynylpyridine] are indicative of a change in receptor function and kinetics for the Norway rat glutamate receptor, metabotropic 5 [GeneSymbol:Grm5 | GeneID:24418 | Uniprot_SwissProt_Accession:P31424].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-2-Methyl-6-phenylethynylpyridine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 226, + "assayName": "NVS_GPCR_rmMGluR5", + "assayDesc": "NVS_GPCR_rmMGluR5 is a biochemical, single-readout assay that uses extracted gene-proteins from Rat whole brain in a tissue-based cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 48-well plate.", + "timepointHr": 1.5, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat whole brain", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 389, + "geneName": "glutamate receptor, metabotropic 5", + "description": null, + "geneSymbol": "Grm5", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24418, + "officialSymbol": "Grm5", + "officialFullName": "glutamate receptor, metabotropic 5", + "uniprotAccessionNumber": "P31424" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/11814808", + "pmid": 11814808, + "title": "[(3)H]-M-MPEP, a potent, subtype-selective radioligand for the metabotropic glutamate receptor subtype 5", + "author": "Gasparini F, Andres H, Flor PJ, Heinrich M, Inderbitzin W, Lingenhöhl K, Müller H, Munk VC, Omilusik K, Stierlin C, Stoehr N, Vranesic I, Kuhn R", + "citation": "Gasparini F, Andres H, Flor PJ, Heinrich M, Inderbitzin W, Lingenhöhl K, Müller H, Munk VC, Omilusik K, Stierlin C, Stoehr N, Vranesic I, Kuhn R. [(3)H]-M-MPEP, a potent, subtype-selective radioligand for the metabotropic glutamate receptor subtype 5. Bioorg Med Chem Lett. 2002 Feb 11;12(3):407-9. PubMed PMID: 11814808.", + "otherId": "0", + "citationId": 186, + "otherSource": "" + } + }, + { + "aeid": 676, + "assayComponentEndpointName": "NVS_GPCR_rNK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rNK1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rNK1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Tacr1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Substance P", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 413, + "assayComponentName": "NVS_GPCR_rNK1", + "assayComponentDesc": "NVS_GPCR_rNK1 is one of one assay component(s) measured or calculated from the NVS_GPCR_rNK1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Substance P] are indicative of a change in receptor function and kinetics for the Norway rat tachykinin receptor 1 [GeneSymbol:Tacr1 | GeneID:24807 | Uniprot_SwissProt_Accession:P14600].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Substance P", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 227, + "assayName": "NVS_GPCR_rNK1", + "assayDesc": "NVS_GPCR_rNK1 is a biochemical, single-readout assay that uses extracted gene-proteins from Rat submaxillary gland membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "salivary gland", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat submaxillary gland membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 393, + "geneName": "tachykinin receptor 1", + "description": null, + "geneSymbol": "Tacr1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24807, + "officialSymbol": "Tacr1", + "officialFullName": "tachykinin receptor 1", + "uniprotAccessionNumber": "P14600" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1718474", + "pmid": 1718474, + "title": "Pharmacology of neurokinin receptors", + "author": "Regoli D, Nantel F", + "citation": "Regoli D, Nantel F. Pharmacology of neurokinin receptors. Biopolymers. 1991 May;31(6):777-83. Review. PubMed PMID: 1718474.", + "otherId": "0", + "citationId": 22, + "otherSource": "" + } + }, + { + "aeid": 677, + "assayComponentEndpointName": "NVS_GPCR_rNK3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rNK3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rNK3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Tacr3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Eledoisin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 414, + "assayComponentName": "NVS_GPCR_rNK3", + "assayComponentDesc": "NVS_GPCR_rNK3 is one of one assay component(s) measured or calculated from the NVS_GPCR_rNK3 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Eledoisin] are indicative of a change in receptor function and kinetics for the Norway rat tachykinin receptor 3 [GeneSymbol:Tacr3 | GeneID:24808 | Uniprot_SwissProt_Accession:P16177].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Eledoisin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 228, + "assayName": "NVS_GPCR_rNK3", + "assayDesc": "NVS_GPCR_rNK3 is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes in a tissue-based cell-free assay. Measurements were taken 2 hours after chemical dosing in a 48-well plate.", + "timepointHr": 2.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 394, + "geneName": "tachykinin receptor 3", + "description": null, + "geneSymbol": "Tacr3", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24808, + "officialSymbol": "Tacr3", + "officialFullName": "tachykinin receptor 3", + "uniprotAccessionNumber": "P16177" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1718474", + "pmid": 1718474, + "title": "Pharmacology of neurokinin receptors", + "author": "Regoli D, Nantel F", + "citation": "Regoli D, Nantel F. Pharmacology of neurokinin receptors. Biopolymers. 1991 May;31(6):777-83. Review. PubMed PMID: 1718474.", + "otherId": "0", + "citationId": 22, + "otherSource": "" + } + }, + { + "aeid": 678, + "assayComponentEndpointName": "NVS_GPCR_rNTS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rNTS was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rNTS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Ntsr1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Neurotensin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 415, + "assayComponentName": "NVS_GPCR_rNTS", + "assayComponentDesc": "NVS_GPCR_rNTS is one of one assay component(s) measured or calculated from the NVS_GPCR_rNTS assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-neurotensin] are indicative of a change in receptor function and kinetics for the Norway rat neurotensin receptor 1 [GeneSymbol:Ntsr1 | GeneID:366274 | Uniprot_SwissProt_Accession:P20789].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-neurotensin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 229, + "assayName": "NVS_GPCR_rNTS", + "assayDesc": "NVS_GPCR_rNTS is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 455, + "geneName": "neurotensin receptor 1", + "description": null, + "geneSymbol": "Ntsr1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 366274, + "officialSymbol": "Ntsr1", + "officialFullName": "neurotensin receptor 1", + "uniprotAccessionNumber": "P20789" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/6744039", + "pmid": 6744039, + "title": "Specific binding of tritiated neurotensin to rat brain membranes: characterization and regional distribution", + "author": "Goedert M, Pittaway K, Williams BJ, Emson PC", + "citation": "Goedert M, Pittaway K, Williams BJ, Emson PC. Specific binding of tritiated neurotensin to rat brain membranes: characterization and regional distribution. Brain Res. 1984 Jun 18;304(1):71-81. PubMed PMID: 6744039.", + "otherId": "0", + "citationId": 129, + "otherSource": "" + } + }, + { + "aeid": 679, + "assayComponentEndpointName": "NVS_GPCR_rOpiate_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rOpiate_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rOpiate_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Oprm1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Naloxone HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 416, + "assayComponentName": "NVS_GPCR_rOpiate_NonSelective", + "assayComponentDesc": "NVS_GPCR_rOpiate_NonSelective is one of one assay component(s) measured or calculated from the NVS_GPCR_rOpiate_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Naloxone] are indicative of a change in receptor function and kinetics for the Norway rat opioid receptor, mu 1 [GeneSymbol:Oprm1 | GeneID:25601 | Uniprot_SwissProt_Accession:P33535].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Naloxone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 230, + "assayName": "NVS_GPCR_rOpiate_NonSelective", + "assayDesc": "NVS_GPCR_rOpiate_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 48-well plate.", + "timepointHr": 1.5, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 411, + "geneName": "opioid receptor, mu 1", + "description": null, + "geneSymbol": "Oprm1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25601, + "officialSymbol": "Oprm1", + "officialFullName": "opioid receptor, mu 1", + "uniprotAccessionNumber": "P33535" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/4127185", + "pmid": 4127185, + "title": "Regional distribution of opiate receptor binding in monkey and human brain", + "author": "Kuhar MJ, Pert CB, Snyder SH", + "citation": "Kuhar MJ, Pert CB, Snyder SH. Regional distribution of opiate receptor binding in monkey and human brain. Nature. 1973 Oct 26;245(5426):447-50. PubMed PMID: 4127185.", + "otherId": "0", + "citationId": 106, + "otherSource": "" + } + }, + { + "aeid": 680, + "assayComponentEndpointName": "NVS_GPCR_rOpiate_NonSelectiveNa", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rOpiate_NonSelectiveNa was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rOpiate_NonSelectiveNa, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Oprm1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Naloxone HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 417, + "assayComponentName": "NVS_GPCR_rOpiate_NonSelectiveNa", + "assayComponentDesc": "NVS_GPCR_rOpiate_NonSelectiveNa is one of one assay component(s) measured or calculated from the NVS_GPCR_rOpiate_NonSelectiveNa assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Naloxone] are indicative of a change in receptor binding affinity due to allosteric binding of sodium ions for the Norway rat opioid receptor, mu 1 [GeneSymbol:Oprm1 | GeneID:25601 | Uniprot_SwissProt_Accession:P33535].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Naloxone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 231, + "assayName": "NVS_GPCR_rOpiate_NonSelectiveNa", + "assayDesc": "NVS_GPCR_rOpiate_NonSelectiveNa is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 48-well plate.", + "timepointHr": 1.5, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 411, + "geneName": "opioid receptor, mu 1", + "description": null, + "geneSymbol": "Oprm1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25601, + "officialSymbol": "Oprm1", + "officialFullName": "opioid receptor, mu 1", + "uniprotAccessionNumber": "P33535" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/4127185", + "pmid": 4127185, + "title": "Regional distribution of opiate receptor binding in monkey and human brain", + "author": "Kuhar MJ, Pert CB, Snyder SH", + "citation": "Kuhar MJ, Pert CB, Snyder SH. Regional distribution of opiate receptor binding in monkey and human brain. Nature. 1973 Oct 26;245(5426):447-50. PubMed PMID: 4127185.", + "otherId": "0", + "citationId": 106, + "otherSource": "" + } + }, + { + "aeid": 681, + "assayComponentEndpointName": "NVS_GPCR_rOXT", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rOXT was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rOXT, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Oxtr. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Oxytocin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 418, + "assayComponentName": "NVS_GPCR_rOXT", + "assayComponentDesc": "NVS_GPCR_rOXT is one of one assay component(s) measured or calculated from the NVS_GPCR_rOXT assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Oxytocin] are indicative of a change in receptor function and kinetics for the Norway rat oxytocin receptor [GeneSymbol:Oxtr | GeneID:25342 | Uniprot_SwissProt_Accession:P70536].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Oxytocin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 232, + "assayName": "NVS_GPCR_rOXT", + "assayDesc": "NVS_GPCR_rOXT is a biochemical, single-readout assay that uses extracted gene-proteins from Rat uterine membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "uterus", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat uterine membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 406, + "geneName": "oxytocin receptor", + "description": null, + "geneSymbol": "Oxtr", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25342, + "officialSymbol": "Oxtr", + "officialFullName": "oxytocin receptor", + "uniprotAccessionNumber": "P70536" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2163875", + "pmid": 2163875, + "title": "Identification of functional oxytocin receptors in lactating rat mammary gland in vitro", + "author": "Pettibone DJ, Woyden CJ, Totaro JA", + "citation": "Pettibone DJ, Woyden CJ, Totaro JA. Identification of functional oxytocin receptors in lactating rat mammary gland in vitro. Eur J Pharmacol. 1990 Apr 25;188(4-5):235-41. PubMed PMID: 2163875.", + "otherId": "0", + "citationId": 32, + "otherSource": "" + } + }, + { + "aeid": 682, + "assayComponentEndpointName": "NVS_GPCR_rSST", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rSST was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rSST, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Sstr1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Somatostatin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 419, + "assayComponentName": "NVS_GPCR_rSST", + "assayComponentDesc": "NVS_GPCR_rSST is one of one assay component(s) measured or calculated from the NVS_GPCR_rSST assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Somatostatin-14 (Tyr11)] are indicative of a change in receptor function and kinetics for the Norway rat somatostatin receptor 1 [GeneSymbol:Sstr1 | GeneID:25033 | Uniprot_SwissProt_Accession:P28646].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Somatostatin-14 (Tyr11)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 233, + "assayName": "NVS_GPCR_rSST", + "assayDesc": "NVS_GPCR_rSST is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 400, + "geneName": "somatostatin receptor 1", + "description": null, + "geneSymbol": "Sstr1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25033, + "officialSymbol": "Sstr1", + "officialFullName": "somatostatin receptor 1", + "uniprotAccessionNumber": "P28646" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2572690", + "pmid": 2572690, + "title": "Analogs of somatostatin selectively label distinct subtypes of somatostatin receptors in rat brain", + "author": "Raynor K, Reisine T", + "citation": "Raynor K, Reisine T. Analogs of somatostatin selectively label distinct subtypes of somatostatin receptors in rat brain. J Pharmacol Exp Ther. 1989 Nov;251(2):510-7. PubMed PMID: 2572690.", + "otherId": "0", + "citationId": 62, + "otherSource": "" + } + }, + { + "aeid": 683, + "assayComponentEndpointName": "NVS_GPCR_rTRH", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rTRH was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rTRH, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Trhr. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TRH", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 420, + "assayComponentName": "NVS_GPCR_rTRH", + "assayComponentDesc": "NVS_GPCR_rTRH is one of one assay component(s) measured or calculated from the NVS_GPCR_rTRH assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-(3-methylHis[2])-TRH] are indicative of a change in receptor function and kinetics for the Norway rat thyrotropin releasing hormone receptor [GeneSymbol:Trhr | GeneID:25570 | Uniprot_SwissProt_Accession:Q01717].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-(3-methylHis[2])-TRH", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 234, + "assayName": "NVS_GPCR_rTRH", + "assayDesc": "NVS_GPCR_rTRH is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 4 hours after chemical dosing in a 48-well plate.", + "timepointHr": 4.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 410, + "geneName": "thyrotropin releasing hormone receptor", + "description": null, + "geneSymbol": "Trhr", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25570, + "officialSymbol": "Trhr", + "officialFullName": "thyrotropin releasing hormone receptor", + "uniprotAccessionNumber": "Q01717" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/169955", + "pmid": 169955, + "title": "Thyrotropin releasing hormone (TRH): apparent receptor binding in rat brain membranes", + "author": "Burt DR, Snyder SH", + "citation": "Burt DR, Snyder SH. Thyrotropin releasing hormone (TRH): apparent receptor binding in rat brain membranes. Brain Res. 1975 Aug 8;93(2):309-28. PubMed PMID: 169955.", + "otherId": "0", + "citationId": 3, + "otherSource": "" + } + }, + { + "aeid": 684, + "assayComponentEndpointName": "NVS_GPCR_rV1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rV1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rV1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Avpr1a. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "(Phenyl[1]ac, D-Tyr(Me)[2],Arg[6,8],Lys-NH2[9])-vasopressin;Arg8-Vasopressin (AVP)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 421, + "assayComponentName": "NVS_GPCR_rV1", + "assayComponentDesc": "NVS_GPCR_rV1 is one of one assay component(s) measured or calculated from the NVS_GPCR_rV1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[phenylanyl-3,4,5-3H(N)]-L-Arg8-Vasopressin] are indicative of a change in receptor function and kinetics for the Norway rat arginine vasopressin receptor 1A [GeneSymbol:Avpr1a | GeneID:25107 | Uniprot_SwissProt_Accession:P30560].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[phenylanyl-3,4,5-3H(N)]-L-Arg8-Vasopressin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 235, + "assayName": "NVS_GPCR_rV1", + "assayDesc": "NVS_GPCR_rV1 is a biochemical, single-readout assay that uses extracted gene-proteins from Rat liver membranes in a tissue-based cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 48-well plate.", + "timepointHr": 1.5, + "organismId": 10116, + "organism": "rat", + "tissue": "liver", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat liver membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 404, + "geneName": "arginine vasopressin receptor 1A", + "description": null, + "geneSymbol": "Avpr1a", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25107, + "officialSymbol": "Avpr1a", + "officialFullName": "arginine vasopressin receptor 1A", + "uniprotAccessionNumber": "P30560" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/3004905", + "pmid": 3004905, + "title": "Characterization of a specific, high affinity [3H]arginine8 vasopressin-binding site on liver microsomes from different strains of rat and the role of magnesium", + "author": "Gopalakrishnan V, Triggle CR, Sulakhe PV, McNeill JR", + "citation": "Gopalakrishnan V, Triggle CR, Sulakhe PV, McNeill JR. Characterization of a specific, high affinity [3H]arginine8 vasopressin-binding site on liver microsomes from different strains of rat and the role of magnesium. Endocrinology. 1986 Mar;118(3):990-7. PubMed PMID: 3004905.", + "otherId": "0", + "citationId": 88, + "otherSource": "" + } + }, + { + "aeid": 685, + "assayComponentEndpointName": "NVS_GPCR_rVIP_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_GPCR_rVIP_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_GPCR_rVIP_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Vipr1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is secretin receptor.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Vasoactive intestinal peptide (VIP)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "secretin receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 422, + "assayComponentName": "NVS_GPCR_rVIP_NonSelective", + "assayComponentDesc": "NVS_GPCR_rVIP_NonSelective is one of one assay component(s) measured or calculated from the NVS_GPCR_rVIP_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Vasoactive intestinal peptide] are indicative of a change in receptor function and kinetics for the Norway rat vasoactive intestinal peptide receptor 1 [GeneSymbol:Vipr1 | GeneID:24875 | Uniprot_SwissProt_Accession:P30083].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Vasoactive intestinal peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 236, + "assayName": "NVS_GPCR_rVIP_NonSelective", + "assayDesc": "NVS_GPCR_rVIP_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 395, + "geneName": "vasoactive intestinal peptide receptor 1", + "description": null, + "geneSymbol": "Vipr1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24875, + "officialSymbol": "Vipr1", + "officialFullName": "vasoactive intestinal peptide receptor 1", + "uniprotAccessionNumber": "P30083" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2472937", + "pmid": 2472937, + "title": "Distribution of vasoactive intestinal polypeptide and substance P receptors in human colon and small intestine", + "author": "Korman LY, Sayadi H, Bass B, Moody TW, Harmon JW", + "citation": "Korman LY, Sayadi H, Bass B, Moody TW, Harmon JW. Distribution of vasoactive intestinal polypeptide and substance P receptors in human colon and small intestine. Dig Dis Sci. 1989 Jul;34(7):1100-8. PubMed PMID: 2472937.", + "otherId": "0", + "citationId": 54, + "otherSource": "" + } + }, + { + "aeid": 686, + "assayComponentEndpointName": "NVS_IC_hKhERGCh", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_IC_hKhERGCh was analyzed into 1 assay endpoint. This assay endpoint, NVS_IC_hKhERGCh, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene KCNH2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is potassium channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Terfenadine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "potassium channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 423, + "assayComponentName": "NVS_IC_hKhERGCh", + "assayComponentDesc": "NVS_IC_hKhERGCh is one of one assay component(s) measured or calculated from the NVS_IC_hKhERGCh assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Astemizole] are indicative of a change in receptor function and kinetics for the human potassium voltage-gated channel, subfamily H (eag-related), member 2 [GeneSymbol:KCNH2 | GeneID:3757 | Uniprot_SwissProt_Accession:Q12809].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Astemizole", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 237, + "assayName": "NVS_IC_hKhERGCh", + "assayDesc": "NVS_IC_hKhERGCh is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 0.75 hour after chemical dosing in a 48-well plate.", + "timepointHr": 0.75, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 184, + "geneName": "potassium voltage-gated channel, subfamily H (eag-related), member 2", + "description": null, + "geneSymbol": "KCNH2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3757, + "officialSymbol": "KCNH2", + "officialFullName": "potassium voltage-gated channel, subfamily H (eag-related), member 2", + "uniprotAccessionNumber": "Q12809" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/10376921", + "pmid": 10376921, + "title": "Block of HERG potassium channels by the antihistamine astemizole and its metabolites desmethylastemizole and norastemizole", + "author": "Zhou Z, Vorperian VR, Gong Q, Zhang S, January CT", + "citation": "Zhou Z, Vorperian VR, Gong Q, Zhang S, January CT. Block of HERG potassium channels by the antihistamine astemizole and its metabolites desmethylastemizole and norastemizole. J Cardiovasc Electrophysiol. 1999 Jun;10(6):836-43. PubMed PMID: 10376921.", + "otherId": "0", + "citationId": 177, + "otherSource": "" + } + }, + { + "aeid": 687, + "assayComponentEndpointName": "NVS_IC_rCaBTZCHL", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_IC_rCaBTZCHL was analyzed into 1 assay endpoint. This assay endpoint, NVS_IC_rCaBTZCHL, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Cacna1a. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is calcium channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Diltiazem HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "calcium channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 424, + "assayComponentName": "NVS_IC_rCaBTZCHL", + "assayComponentDesc": "NVS_IC_rCaBTZCHL is one of one assay component(s) measured or calculated from the NVS_IC_rCaBTZCHL assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Diltiazem] are indicative of a change in receptor function and kinetics for the Norway rat calcium channel, voltage-dependent, P/Q type, alpha 1A subunit [GeneSymbol:Cacna1a | GeneID:25398 | Uniprot_SwissProt_Accession:P54282].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Diltiazem", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 238, + "assayName": "NVS_IC_rCaBTZCHL", + "assayDesc": "NVS_IC_rCaBTZCHL is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes in a tissue-based cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 48-well plate.", + "timepointHr": 1.5, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 407, + "geneName": "calcium channel, voltage-dependent, P/Q type, alpha 1A subunit", + "description": null, + "geneSymbol": "Cacna1a", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25398, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P54282" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2410283", + "pmid": 2410283, + "title": "[3H]diltiazem binding to calcium channel antagonists recognition sites in rat cerebral cortex", + "author": "Schoemaker H, Langer SZ", + "citation": "Schoemaker H, Langer SZ. [3H]diltiazem binding to calcium channel antagonists recognition sites in rat cerebral cortex. Eur J Pharmacol. 1985 May 8;111(2):273-7. PubMed PMID: 2410283.", + "otherId": "0", + "citationId": 46, + "otherSource": "" + } + }, + { + "aeid": 688, + "assayComponentEndpointName": "NVS_IC_rCaChN", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_IC_rCaChN was analyzed into 1 assay endpoint. This assay endpoint, NVS_IC_rCaChN, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Cacna1b. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is calcium channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "W-Conotoxin GVIA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "calcium channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 425, + "assayComponentName": "NVS_IC_rCaChN", + "assayComponentDesc": "NVS_IC_rCaChN is one of one assay component(s) measured or calculated from the NVS_IC_rCaChN assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-o-conotoxin GVIA] are indicative of a change in receptor function and kinetics for the Norway rat calcium channel, voltage-dependent, N type, alpha 1B subunit [GeneSymbol:Cacna1b | GeneID:257648 | Uniprot_SwissProt_Accession:Q02294].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-o-conotoxin GVIA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 239, + "assayName": "NVS_IC_rCaChN", + "assayDesc": "NVS_IC_rCaChN is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 446, + "geneName": "calcium channel, voltage-dependent, N type, alpha 1B subunit", + "description": null, + "geneSymbol": "Cacna1b", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 257648, + "officialSymbol": "Cacna1b", + "officialFullName": "calcium channel, voltage-dependent, N type, alpha 1B subunit", + "uniprotAccessionNumber": "Q02294" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2172254", + "pmid": 2172254, + "title": "The polyamine spermine affects omega-conotoxin binding and function at N-type voltage-sensitive calcium channels", + "author": "Pullan LM, Keith RA, LaMonte D, Stumpo RJ, Salama AI", + "citation": "Pullan LM, Keith RA, LaMonte D, Stumpo RJ, Salama AI. The polyamine spermine affects omega-conotoxin binding and function at N-type voltage-sensitive calcium channels. J Auton Pharmacol. 1990 Aug;10(4):213-9. PubMed PMID: 2172254.", + "otherId": "0", + "citationId": 36, + "otherSource": "" + } + }, + { + "aeid": 689, + "assayComponentEndpointName": "NVS_IC_rCaDHPRCh_L", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_IC_rCaDHPRCh_L was analyzed into 1 assay endpoint. This assay endpoint, NVS_IC_rCaDHPRCh_L, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Cacna1a. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is calcium channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Nifedipine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "calcium channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 426, + "assayComponentName": "NVS_IC_rCaDHPRCh_L", + "assayComponentDesc": "NVS_IC_rCaDHPRCh_L is one of one assay component(s) measured or calculated from the NVS_IC_rCaDHPRCh_L assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Nitrendipine] are indicative of a change in receptor function and kinetics for the Norway rat calcium channel, voltage-dependent, P/Q type, alpha 1A subunit [GeneSymbol:Cacna1a | GeneID:25398 | Uniprot_SwissProt_Accession:P54282].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Nitrendipine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 240, + "assayName": "NVS_IC_rCaDHPRCh_L", + "assayDesc": "NVS_IC_rCaDHPRCh_L is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 407, + "geneName": "calcium channel, voltage-dependent, P/Q type, alpha 1A subunit", + "description": null, + "geneSymbol": "Cacna1a", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25398, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P54282" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/6422256", + "pmid": 6422256, + "title": "Tissue heterogeneity of calcium channel antagonist binding sites labeled by [3H]nitrendipine", + "author": "Gould RJ, Murphy KM, Snyder SH", + "citation": "Gould RJ, Murphy KM, Snyder SH. Tissue heterogeneity of calcium channel antagonist binding sites labeled by [3H]nitrendipine. Mol Pharmacol. 1984 Mar;25(2):235-41. PubMed PMID: 6422256.", + "otherId": "0", + "citationId": 125, + "otherSource": "" + } + }, + { + "aeid": 690, + "assayComponentEndpointName": "NVS_IC_rKAR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_IC_rKAR was analyzed into 1 assay endpoint. This assay endpoint, NVS_IC_rKAR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Grik1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Kainic acid", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 427, + "assayComponentName": "NVS_IC_rKAR", + "assayComponentDesc": "NVS_IC_rKAR is one of one assay component(s) measured or calculated from the NVS_IC_rKAR assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Kainic acid] are indicative of a change in receptor function and kinetics for the Norway rat glutamate receptor, ionotropic, kainate 1 [GeneSymbol:Grik1 | GeneID:29559 | Uniprot_SwissProt_Accession:P22756].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Kainic acid", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 241, + "assayName": "NVS_IC_rKAR", + "assayDesc": "NVS_IC_rKAR is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 420, + "geneName": "glutamate receptor, ionotropic, kainate 1", + "description": null, + "geneSymbol": "Grik1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 29559, + "officialSymbol": "Grik1", + "officialFullName": "glutamate receptor, ionotropic, kainate 1", + "uniprotAccessionNumber": "P22756" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/492142", + "pmid": 492142, + "title": "Specific binding of [3H]kainic acid to receptor sites in rat brain", + "author": "London ED, Coyle JT", + "citation": "London ED, Coyle JT. Specific binding of [3H]kainic acid to receptor sites in rat brain. Mol Pharmacol. 1979 May;15(3):492-505. PubMed PMID: 492142.", + "otherId": "0", + "citationId": 9, + "otherSource": "" + } + }, + { + "aeid": 691, + "assayComponentEndpointName": "NVS_IC_rKATPCh", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_IC_rKATPCh was analyzed into 1 assay endpoint. This assay endpoint, NVS_IC_rKATPCh, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Kcnj1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is potassium channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Glibenclamide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "potassium channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 428, + "assayComponentName": "NVS_IC_rKATPCh", + "assayComponentDesc": "NVS_IC_rKATPCh is one of one assay component(s) measured or calculated from the NVS_IC_rKATPCh assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Glibenclamide] are indicative of a change in receptor function and kinetics for the Norway rat potassium inwardly-rectifying channel, subfamily J, member 1 [GeneSymbol:Kcnj1 | GeneID:24521 | Uniprot_SwissProt_Accession:P35560].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Glibenclamide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 242, + "assayName": "NVS_IC_rKATPCh", + "assayDesc": "NVS_IC_rKATPCh is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes in a tissue-based cell-free assay. Measurements were taken 2 hours after chemical dosing in a 48-well plate.", + "timepointHr": 2.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 391, + "geneName": "potassium inwardly-rectifying channel, subfamily J, member 1", + "description": null, + "geneSymbol": "Kcnj1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24521, + "officialSymbol": "Kcnj1", + "officialFullName": "potassium inwardly-rectifying channel, subfamily J, member 1", + "uniprotAccessionNumber": "P35560" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/3144003", + "pmid": 3144003, + "title": "Characterization, purification, and affinity labeling of the brain [3H]glibenclamide-binding protein, a putative neuronal ATP-regulated K+ channel", + "author": "Bernardi H, Fosset M, Lazdunski M", + "citation": "Bernardi H, Fosset M, Lazdunski M. Characterization, purification, and affinity labeling of the brain [3H]glibenclamide-binding protein, a putative neuronal ATP-regulated K+ channel. Proc Natl Acad Sci U S A. 1988 Dec;85(24):9816-20. PubMed PMID: 3144003; PubMed Central PMCID: PMC282872.", + "otherId": "0", + "citationId": 96, + "otherSource": "" + } + }, + { + "aeid": 692, + "assayComponentEndpointName": "NVS_IC_rKCaCh", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_IC_rKCaCh was analyzed into 1 assay endpoint. This assay endpoint, NVS_IC_rKCaCh, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Kcnn1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is potassium channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Apamin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "potassium channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 429, + "assayComponentName": "NVS_IC_rKCaCh", + "assayComponentDesc": "NVS_IC_rKCaCh is one of one assay component(s) measured or calculated from the NVS_IC_rKCaCh assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-Apamin] are indicative of a change in receptor function and kinetics for the Norway rat potassium intermediate/small conductance calcium-activated channel, subfamily N, member 1 [GeneSymbol:Kcnn1 | GeneID:54261 | Uniprot_SwissProt_Accession:P70606].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-Apamin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 243, + "assayName": "NVS_IC_rKCaCh", + "assayDesc": "NVS_IC_rKCaCh is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 428, + "geneName": "potassium intermediate/small conductance calcium-activated channel, subfamily N, member 1", + "description": "provisional", + "geneSymbol": "Kcnn1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 54261, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P70606" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/428392", + "pmid": 428392, + "title": "Bee venom neurotoxin (apamin): iodine labeling and characterization of binding sites", + "author": "Habermann E, Fischer K", + "citation": "Habermann E, Fischer K. Bee venom neurotoxin (apamin): iodine labeling and characterization of binding sites. Eur J Biochem. 1979 Mar;94(2):355-64. PubMed PMID: 428392.", + "otherId": "0", + "citationId": 6, + "otherSource": "" + } + }, + { + "aeid": 693, + "assayComponentEndpointName": "NVS_IC_rNaCh_site2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_IC_rNaCh_site2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_IC_rNaCh_site2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Scn1a. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is sodium channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Aconitine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "sodium channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 430, + "assayComponentName": "NVS_IC_rNaCh_site2", + "assayComponentDesc": "NVS_IC_rNaCh_site2 is one of one assay component(s) measured or calculated from the NVS_IC_rNaCh_site2 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Batrachotoxin] are indicative of a change in receptor function and kinetics for the Norway rat sodium channel, voltage-gated, type I, alpha subunit [GeneSymbol:Scn1a | GeneID:81574 | Uniprot_SwissProt_Accession:P04774].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Batrachotoxin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 244, + "assayName": "NVS_IC_rNaCh_site2", + "assayDesc": "NVS_IC_rNaCh_site2 is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 436, + "geneName": "sodium channel, voltage-gated, type I, alpha subunit", + "description": null, + "geneSymbol": "Scn1a", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 81574, + "officialSymbol": "Scn1a", + "officialFullName": "sodium channel, voltage-gated, type I, alpha subunit", + "uniprotAccessionNumber": "P04774" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/6300644", + "pmid": 6300644, + "title": "Batrachotoxin-induced depolarization and [3H]batrachotoxinin-a 20 alpha-benzoate binding in a vesicular preparation from guinea pig cerebral cortex", + "author": "Creveling CR, McNeal ET, Daly JW, Brown GB", + "citation": "Creveling CR, McNeal ET, Daly JW, Brown GB. Batrachotoxin-induced depolarization and [3H]batrachotoxinin-a 20 alpha-benzoate binding in a vesicular preparation from guinea pig cerebral cortex. Mol Pharmacol. 1983 Mar;23(2):350-8. PubMed PMID: 6300644.", + "otherId": "0", + "citationId": 117, + "otherSource": "" + } + }, + { + "aeid": 694, + "assayComponentEndpointName": "NVS_LGIC_bGABAR_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_LGIC_bGABAR_Agonist was analyzed into 1 assay endpoint. This assay endpoint, NVS_LGIC_bGABAR_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene GABRA1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GABA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 431, + "assayComponentName": "NVS_LGIC_bGABAR_Agonist", + "assayComponentDesc": "NVS_LGIC_bGABAR_Agonist is one of one assay component(s) measured or calculated from the NVS_LGIC_bGABAR_Agonist assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-GABA] are indicative of a change in receptor agonist activity for the cattle gamma-aminobutyric acid (GABA) A receptor, alpha 1 [GeneSymbol:GABRA1 | GeneID:780973 | Uniprot_SwissProt_Accession:P08219].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-GABA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 245, + "assayName": "NVS_LGIC_bGABAR_Agonist", + "assayDesc": "NVS_LGIC_bGABAR_Agonist is a biochemical, single-readout assay that uses extracted gene-proteins from Bovine cerebellar membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 9913, + "organism": "bovine", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Bovine cerebellar membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 465, + "geneName": "gamma-aminobutyric acid (GABA) A receptor, alpha 1", + "description": null, + "geneSymbol": "GABRA1", + "organismId": 4, + "trackStatus": "live", + "entrezGeneId": 780973, + "officialSymbol": "GABRA1", + "officialFullName": "gamma-aminobutyric acid (GABA) A receptor, alpha 1", + "uniprotAccessionNumber": "P08219" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/191147", + "pmid": 191147, + "title": "Stereospecificity and structure--activity requirements of GABA receptor binding in rat brain", + "author": "Enna SJ, Collins JF, Snyder SH", + "citation": "Enna SJ, Collins JF, Snyder SH. Stereospecificity and structure--activity requirements of GABA receptor binding in rat brain. Brain Res. 1977 Mar 18;124(1):185-90. PubMed PMID: 191147.", + "otherId": "0", + "citationId": 5, + "otherSource": "" + } + }, + { + "aeid": 695, + "assayComponentEndpointName": "NVS_LGIC_bGABARa1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_LGIC_bGABARa1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_LGIC_bGABARa1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene GABRA1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ro 15-1788 (Flumazenil)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 432, + "assayComponentName": "NVS_LGIC_bGABARa1", + "assayComponentDesc": "NVS_LGIC_bGABARa1 is one of one assay component(s) measured or calculated from the NVS_LGIC_bGABARa1 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Flunitrazepam] are indicative of a change in receptor function and kinetics for the cattle gamma-aminobutyric acid (GABA) A receptor, alpha 1 [GeneSymbol:GABRA1 | GeneID:780973 | Uniprot_SwissProt_Accession:P08219].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Flunitrazepam", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 246, + "assayName": "NVS_LGIC_bGABARa1", + "assayDesc": "NVS_LGIC_bGABARa1 is a biochemical, single-readout assay that uses extracted gene-proteins from Bovine cortical membranes in a tissue-based cell-free assay. Measurements were taken 0.75 hour after chemical dosing in a 48-well plate.", + "timepointHr": 0.75, + "organismId": 9913, + "organism": "bovine", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Bovine cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 465, + "geneName": "gamma-aminobutyric acid (GABA) A receptor, alpha 1", + "description": null, + "geneSymbol": "GABRA1", + "organismId": 4, + "trackStatus": "live", + "entrezGeneId": 780973, + "officialSymbol": "GABRA1", + "officialFullName": "gamma-aminobutyric acid (GABA) A receptor, alpha 1", + "uniprotAccessionNumber": "P08219" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/3005837", + "pmid": 3005837, + "title": "Regional difference in brain benzodiazepine receptor carbohydrates", + "author": "Sweetnam PM, Tallman JF", + "citation": "Sweetnam PM, Tallman JF. Regional difference in brain benzodiazepine receptor carbohydrates. Mol Pharmacol. 1986 Mar;29(3):299-306. PubMed PMID: 3005837.", + "otherId": "0", + "citationId": 89, + "otherSource": "" + } + }, + { + "aeid": 696, + "assayComponentEndpointName": "NVS_LGIC_bGABARa5", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_LGIC_bGABARa5 was analyzed into 1 assay endpoint. This assay endpoint, NVS_LGIC_bGABARa5, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene GABRA5. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "L-655,708", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 433, + "assayComponentName": "NVS_LGIC_bGABARa5", + "assayComponentDesc": "NVS_LGIC_bGABARa5 is one of one assay component(s) measured or calculated from the NVS_LGIC_bGABARa5 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-RY80] are indicative of a change in receptor function and kinetics for the cattle gamma-aminobutyric acid (GABA) A receptor, alpha 5 [GeneSymbol:GABRA5 | GeneID:523515 | Uniprot_SwissProt_Accession:Q08E50].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-RY80", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 247, + "assayName": "NVS_LGIC_bGABARa5", + "assayDesc": "NVS_LGIC_bGABARa5 is a biochemical, single-readout assay that uses extracted gene-proteins from Bovine hippocampal membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 9913, + "organism": "bovine", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Bovine hippocampal membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 463, + "geneName": "gamma-aminobutyric acid (GABA) A receptor, alpha 5", + "description": null, + "geneSymbol": "GABRA5", + "organismId": 4, + "trackStatus": "live", + "entrezGeneId": 523515, + "officialSymbol": "GABRA5", + "officialFullName": "gamma-aminobutyric acid (GABA) A receptor, alpha 5", + "uniprotAccessionNumber": "Q08E50" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/11173064", + "pmid": 11173064, + "title": "Evaluation of native GABA(A) receptors containing an alpha 5 subunit", + "author": "Li M, Szabo A, Rosenberg HC", + "citation": "Li M, Szabo A, Rosenberg HC. Evaluation of native GABA(A) receptors containing an alpha 5 subunit. Eur J Pharmacol. 2001 Feb 9;413(1):63-72. PubMed PMID: 11173064.", + "otherId": "0", + "citationId": 185, + "otherSource": "" + } + }, + { + "aeid": 697, + "assayComponentEndpointName": "NVS_LGIC_h5HT3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_LGIC_h5HT3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_LGIC_h5HT3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene HTR3A. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "MDL-72222", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 434, + "assayComponentName": "NVS_LGIC_h5HT3", + "assayComponentDesc": "NVS_LGIC_h5HT3 is one of one assay component(s) measured or calculated from the NVS_LGIC_h5HT3 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-GR 65630] are indicative of a change in receptor function and kinetics for the human 5-hydroxytryptamine (serotonin) receptor 3A, ionotropic [GeneSymbol:HTR3A | GeneID:3359 | Uniprot_SwissProt_Accession:P46098].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-GR 65630", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 248, + "assayName": "NVS_LGIC_h5HT3", + "assayDesc": "NVS_LGIC_h5HT3 is a biochemical, single-readout assay that uses extracted gene-proteins from HEK293 in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "HEK293", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 166, + "geneName": "5-hydroxytryptamine (serotonin) receptor 3A, ionotropic", + "description": null, + "geneSymbol": "HTR3A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3359, + "officialSymbol": "HTR3A", + "officialFullName": "5-hydroxytryptamine (serotonin) receptor 3A, ionotropic", + "uniprotAccessionNumber": "P46098" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1840227", + "pmid": 1840227, + "title": "5-HT3 receptors and the therapeutic potential of 5-HT3 receptor antagonists", + "author": "Tyers MB", + "citation": "Tyers MB. 5-HT3 receptors and the therapeutic potential of 5-HT3 receptor antagonists. Therapie. 1991 Nov-Dec;46(6):431-5. Review. PubMed PMID: 1840227.", + "otherId": "0", + "citationId": 23, + "otherSource": "" + } + }, + { + "aeid": 698, + "assayComponentEndpointName": "NVS_LGIC_hNNR_NBungSens", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_LGIC_hNNR_NBungSens was analyzed into 1 assay endpoint. This assay endpoint, NVS_LGIC_hNNR_NBungSens, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene CHRNA2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "(+/-)-Epibatidine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 435, + "assayComponentName": "NVS_LGIC_hNNR_NBungSens", + "assayComponentDesc": "NVS_LGIC_hNNR_NBungSens is one of one assay component(s) measured or calculated from the NVS_LGIC_hNNR_NBungSens assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Epibatidine] are indicative of a change in receptor function and kinetics for the human cholinergic receptor, nicotinic, alpha 2 (neuronal) [GeneSymbol:CHRNA2 | GeneID:1135 | Uniprot_SwissProt_Accession:Q15822].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Epibatidine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 249, + "assayName": "NVS_LGIC_hNNR_NBungSens", + "assayDesc": "NVS_LGIC_hNNR_NBungSens is a biochemical, single-readout assay that uses extracted gene-proteins from Human neuroblastoma membrane cells in a tissue-based cell-free assay. Measurements were taken 2 hours after chemical dosing in a 48-well plate.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Human neuroblastoma membrane cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 66, + "geneName": "cholinergic receptor, nicotinic, alpha 2 (neuronal)", + "description": null, + "geneSymbol": "CHRNA2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1135, + "officialSymbol": "CHRNA2", + "officialFullName": "cholinergic receptor, nicotinic, alpha 2 (neuronal)", + "uniprotAccessionNumber": "Q15822" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2197155", + "pmid": 2197155, + "title": "Nicotine receptors in the mammalian brain", + "author": "Luetje CW, Patrick J, Séguéla P", + "citation": "Luetje CW, Patrick J, Séguéla P. Nicotine receptors in the mammalian brain. FASEB J. 1990 Jul;4(10):2753-60. Review. PubMed PMID: 2197155.", + "otherId": "0", + "citationId": 40, + "otherSource": "" + } + }, + { + "aeid": 699, + "assayComponentEndpointName": "NVS_LGIC_rAMPA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_LGIC_rAMPA was analyzed into 1 assay endpoint. This assay endpoint, NVS_LGIC_rAMPA, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Gria1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "(+/-)-AMPA HBr", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 436, + "assayComponentName": "NVS_LGIC_rAMPA", + "assayComponentDesc": "NVS_LGIC_rAMPA is one of one assay component(s) measured or calculated from the NVS_LGIC_rAMPA assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-AMPA] are indicative of a change in receptor function and kinetics for the Norway rat glutamate receptor, ionotropic, AMPA 1 [GeneSymbol:Gria1 | GeneID:50592 | Uniprot_SwissProt_Accession:P19490].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-AMPA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 250, + "assayName": "NVS_LGIC_rAMPA", + "assayDesc": "NVS_LGIC_rAMPA is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 424, + "geneName": "glutamate receptor, ionotropic, AMPA 1", + "description": null, + "geneSymbol": "Gria1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 50592, + "officialSymbol": "Gria1", + "officialFullName": "glutamate receptor, ionotropic, AMPA 1", + "uniprotAccessionNumber": "P19490" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2890112", + "pmid": 2890112, + "title": "Characterization of quisqualate recognition sites in rat brain tissue using DL-[3H]alpha-amino-3-hydroxy-5-methylisoxazole-4-propionic acid (AMPA) and a filtration assay", + "author": "Murphy DE, Snowhill EW, Williams M", + "citation": "Murphy DE, Snowhill EW, Williams M. Characterization of quisqualate recognition sites in rat brain tissue using DL-[3H]alpha-amino-3-hydroxy-5-methylisoxazole-4-propionic acid (AMPA) and a filtration assay. Neurochem Res. 1987 Sep;12(9):775-81. PubMed PMID: 2890112.", + "otherId": "0", + "citationId": 75, + "otherSource": "" + } + }, + { + "aeid": 700, + "assayComponentEndpointName": "NVS_LGIC_rGABAR_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_LGIC_rGABAR_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_LGIC_rGABAR_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Gabra1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GABA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 437, + "assayComponentName": "NVS_LGIC_rGABAR_NonSelective", + "assayComponentDesc": "NVS_LGIC_rGABAR_NonSelective is one of one assay component(s) measured or calculated from the NVS_LGIC_rGABAR_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-GABA] are indicative of a change in receptor function and kinetics for the Norway rat gamma-aminobutyric acid (GABA) A receptor, alpha 1 [GeneSymbol:Gabra1 | GeneID:29705 | Uniprot_SwissProt_Accession:P62813].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-GABA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 251, + "assayName": "NVS_LGIC_rGABAR_NonSelective", + "assayDesc": "NVS_LGIC_rGABAR_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Rat whole brain in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat whole brain", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 421, + "geneName": "gamma-aminobutyric acid (GABA) A receptor, alpha 1", + "description": null, + "geneSymbol": "Gabra1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 29705, + "officialSymbol": "Gabra1", + "officialFullName": "gamma-aminobutyric acid (GABA) A receptor, alpha 1", + "uniprotAccessionNumber": "P62813" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/191147", + "pmid": 191147, + "title": "Stereospecificity and structure--activity requirements of GABA receptor binding in rat brain", + "author": "Enna SJ, Collins JF, Snyder SH", + "citation": "Enna SJ, Collins JF, Snyder SH. Stereospecificity and structure--activity requirements of GABA receptor binding in rat brain. Brain Res. 1977 Mar 18;124(1):185-90. PubMed PMID: 191147.", + "otherId": "0", + "citationId": 5, + "otherSource": "" + } + }, + { + "aeid": 701, + "assayComponentEndpointName": "NVS_LGIC_rGABARa6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_LGIC_rGABARa6 was analyzed into 1 assay endpoint. This assay endpoint, NVS_LGIC_rGABARa6, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Gabra6. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "L-655,708", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 438, + "assayComponentName": "NVS_LGIC_rGABARa6", + "assayComponentDesc": "NVS_LGIC_rGABARa6 is one of one assay component(s) measured or calculated from the NVS_LGIC_rGABARa6 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Ro 15-4513] are indicative of a change in receptor function and kinetics for the Norway rat gamma-aminobutyric acid (GABA) A receptor, alpha 6 [GeneSymbol:Gabra6 | GeneID:29708 | Uniprot_SwissProt_Accession:P30191].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Ro 15-4513", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 252, + "assayName": "NVS_LGIC_rGABARa6", + "assayDesc": "NVS_LGIC_rGABARa6 is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cerebellar membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cerebellar membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 422, + "geneName": "gamma-aminobutyric acid (GABA) A receptor, alpha 6", + "description": null, + "geneSymbol": "Gabra6", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 29708, + "officialSymbol": "Gabra6", + "officialFullName": "gamma-aminobutyric acid (GABA) A receptor, alpha 6", + "uniprotAccessionNumber": "P30191" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/9281599", + "pmid": 9281599, + "title": "Cerebellar gamma-aminobutyric acid type A receptors: pharmacological subtypes revealed by mutant mouse lines", + "author": "Mäkelä R, Uusi-Oukari M, Homanics GE, Quinlan JJ, Firestone LL, Wisden W, Korpi ER", + "citation": "Mäkelä R, Uusi-Oukari M, Homanics GE, Quinlan JJ, Firestone LL, Wisden W, Korpi ER. Cerebellar gamma-aminobutyric acid type A receptors: pharmacological subtypes revealed by mutant mouse lines. Mol Pharmacol. 1997 Sep;52(3):380-8. PubMed PMID: 9281599.", + "otherId": "0", + "citationId": 173, + "otherSource": "" + } + }, + { + "aeid": 702, + "assayComponentEndpointName": "NVS_LGIC_rGluNMDA_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_LGIC_rGluNMDA_Agonist was analyzed into 1 assay endpoint. This assay endpoint, NVS_LGIC_rGluNMDA_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Grin1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "N-methyl-D-aspartate (NMDA)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 439, + "assayComponentName": "NVS_LGIC_rGluNMDA_Agonist", + "assayComponentDesc": "NVS_LGIC_rGluNMDA_Agonist is one of one assay component(s) measured or calculated from the NVS_LGIC_rGluNMDA_Agonist assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-CGP 39653] are indicative of a change in receptor agonist activity for the Norway rat glutamate receptor, ionotropic, N-methyl D-aspartate 1 [GeneSymbol:Grin1 | GeneID:24408 | Uniprot_SwissProt_Accession:P35439].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-CGP 39653", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 253, + "assayName": "NVS_LGIC_rGluNMDA_Agonist", + "assayDesc": "NVS_LGIC_rGluNMDA_Agonist is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 387, + "geneName": "glutamate receptor, ionotropic, N-methyl D-aspartate 1", + "description": null, + "geneSymbol": "Grin1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24408, + "officialSymbol": "Grin1", + "officialFullName": "glutamate receptor, ionotropic, N-methyl D-aspartate 1", + "uniprotAccessionNumber": "P35439" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2899170", + "pmid": 2899170, + "title": "CGS 19755, a selective and competitive N-methyl-D-aspartate-type excitatory amino acid receptor antagonist", + "author": "Lehmann J, Hutchison AJ, McPherson SE, Mondadori C, Schmutz M, Sinton CM, Tsai C, Murphy DE, Steel DJ, Williams M, et al", + "citation": "Lehmann J, Hutchison AJ, McPherson SE, Mondadori C, Schmutz M, Sinton CM, Tsai C, Murphy DE, Steel DJ, Williams M, et al. CGS 19755, a selective and competitive N-methyl-D-aspartate-type excitatory amino acid receptor antagonist. J Pharmacol Exp Ther. 1988 Jul;246(1):65-75. PubMed PMID: 2899170.", + "otherId": "0", + "citationId": 76, + "otherSource": "" + } + }, + { + "aeid": 703, + "assayComponentEndpointName": "NVS_LGIC_rGluNMDA_MK801_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_LGIC_rGluNMDA_MK801_Agonist was analyzed into 1 assay endpoint. This assay endpoint, NVS_LGIC_rGluNMDA_MK801_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Grin1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "(+)-MK-801", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 440, + "assayComponentName": "NVS_LGIC_rGluNMDA_MK801_Agonist", + "assayComponentDesc": "NVS_LGIC_rGluNMDA_MK801_Agonist is one of one assay component(s) measured or calculated from the NVS_LGIC_rGluNMDA_MK801_Agonist assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-MK-801] are indicative of a change in receptor agonist activity for the Norway rat glutamate receptor, ionotropic, N-methyl D-aspartate 1 [GeneSymbol:Grin1 | GeneID:24408 | Uniprot_SwissProt_Accession:P35439].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-MK-801", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 254, + "assayName": "NVS_LGIC_rGluNMDA_MK801_Agonist", + "assayDesc": "NVS_LGIC_rGluNMDA_MK801_Agonist is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 48-well plate.", + "timepointHr": 1.5, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 387, + "geneName": "glutamate receptor, ionotropic, N-methyl D-aspartate 1", + "description": null, + "geneSymbol": "Grin1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24408, + "officialSymbol": "Grin1", + "officialFullName": "glutamate receptor, ionotropic, N-methyl D-aspartate 1", + "uniprotAccessionNumber": "P35439" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2468076", + "pmid": 2468076, + "title": "Biexponential kinetics of [3H]MK-801 binding: evidence for access to closed and open N-methyl-D-aspartate receptor channels", + "author": "Javitt DC, Zukin SR", + "citation": "Javitt DC, Zukin SR. Biexponential kinetics of [3H]MK-801 binding: evidence for access to closed and open N-methyl-D-aspartate receptor channels. Mol Pharmacol. 1989 Apr;35(4):387-93. PubMed PMID: 2468076.", + "otherId": "0", + "citationId": 53, + "otherSource": "" + } + }, + { + "aeid": 704, + "assayComponentEndpointName": "NVS_LGIC_rGlyRStrySens", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_LGIC_rGlyRStrySens was analyzed into 1 assay endpoint. This assay endpoint, NVS_LGIC_rGlyRStrySens, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Glra1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Strychnine nitrate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 441, + "assayComponentName": "NVS_LGIC_rGlyRStrySens", + "assayComponentDesc": "NVS_LGIC_rGlyRStrySens is one of one assay component(s) measured or calculated from the NVS_LGIC_rGlyRStrySens assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-strychnine] are indicative of a change in receptor function and kinetics for the Norway rat glycine receptor, alpha 1 [GeneSymbol:Glra1 | GeneID:25674 | Uniprot_SwissProt_Accession:P07727].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-strychnine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 255, + "assayName": "NVS_LGIC_rGlyRStrySens", + "assayDesc": "NVS_LGIC_rGlyRStrySens is a biochemical, single-readout assay that uses extracted gene-proteins from Rat spinal cord membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat spinal cord membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 414, + "geneName": "glycine receptor, alpha 1", + "description": null, + "geneSymbol": "Glra1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25674, + "officialSymbol": "Glra1", + "officialFullName": "glycine receptor, alpha 1", + "uniprotAccessionNumber": "P07727" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2542450", + "pmid": 2542450, + "title": "Thermodynamics of agonist and antagonist interaction with the strychnine-sensitive glycine receptor", + "author": "Ruiz-Gómez A, García-Calvo M, Vázquez J, Marvizón JC, Valdivieso F, Mayor F Jr", + "citation": "Ruiz-Gómez A, García-Calvo M, Vázquez J, Marvizón JC, Valdivieso F, Mayor F Jr. Thermodynamics of agonist and antagonist interaction with the strychnine-sensitive glycine receptor. J Neurochem. 1989 Jun;52(6):1775-80. PubMed PMID: 2542450.", + "otherId": "0", + "citationId": 56, + "otherSource": "" + } + }, + { + "aeid": 705, + "assayComponentEndpointName": "NVS_LGIC_rNNR_BungSens", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_LGIC_rNNR_BungSens was analyzed into 1 assay endpoint. This assay endpoint, NVS_LGIC_rNNR_BungSens, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Chrna7. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the ion channel intended target family, where the subfamily is ligand-gated ion channel.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methyllycaconitine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "ion channel", + "intendedTargetFamilySub": "ligand-gated ion channel", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 442, + "assayComponentName": "NVS_LGIC_rNNR_BungSens", + "assayComponentDesc": "NVS_LGIC_rNNR_BungSens is one of one assay component(s) measured or calculated from the NVS_LGIC_rNNR_BungSens assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[125I]-a-bungarotoxin] are indicative of a change in receptor function and kinetics for the Norway rat cholinergic receptor, nicotinic, alpha 7 (neuronal) [GeneSymbol:Chrna7 | GeneID:25302 | Uniprot_SwissProt_Accession:Q05941].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[125I]-a-bungarotoxin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 256, + "assayName": "NVS_LGIC_rNNR_BungSens", + "assayDesc": "NVS_LGIC_rNNR_BungSens is a biochemical, single-readout assay that uses extracted gene-proteins from Rat cortical membranes in a tissue-based cell-free assay. Measurements were taken 2.5 hours after chemical dosing in a 48-well plate.", + "timepointHr": 2.5, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat cortical membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 405, + "geneName": "cholinergic receptor, nicotinic, alpha 7 (neuronal)", + "description": null, + "geneSymbol": "Chrna7", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25302, + "officialSymbol": "Chrna7", + "officialFullName": "cholinergic receptor, nicotinic, alpha 7 (neuronal)", + "uniprotAccessionNumber": "Q05941" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2197155", + "pmid": 2197155, + "title": "Nicotine receptors in the mammalian brain", + "author": "Luetje CW, Patrick J, Séguéla P", + "citation": "Luetje CW, Patrick J, Séguéla P. Nicotine receptors in the mammalian brain. FASEB J. 1990 Jul;4(10):2753-60. Review. PubMed PMID: 2197155.", + "otherId": "0", + "citationId": 40, + "otherSource": "" + } + }, + { + "aeid": 706, + "assayComponentEndpointName": "NVS_MP_hPBR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_MP_hPBR was analyzed into 1 assay endpoint. This assay endpoint, NVS_MP_hPBR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene TSPO. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is cholesterol transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "PK11195", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "cholesterol transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 443, + "assayComponentName": "NVS_MP_hPBR", + "assayComponentDesc": "NVS_MP_hPBR is one of one assay component(s) measured or calculated from the NVS_MP_hPBR assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-PK11195] are indicative of a change in transporter function and kinetics for the human translocator protein (18kDa) [GeneSymbol:TSPO | GeneID:706 | Uniprot_SwissProt_Accession:P30536].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-PK11195", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 257, + "assayName": "NVS_MP_hPBR", + "assayDesc": "NVS_MP_hPBR is a biochemical, single-readout assay that uses extracted gene-proteins from Human colonic cell membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "intestinal", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Human colonic cell membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 37, + "geneName": "translocator protein (18kDa)", + "description": null, + "geneSymbol": "TSPO", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 706, + "officialSymbol": "TSPO", + "officialFullName": "translocator protein (18kDa)", + "uniprotAccessionNumber": "P30536" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2837399", + "pmid": 2837399, + "title": "Photoaffinity labeling of peripheral-type benzodiazepine receptors in rat kidney mitochondria with [3H]PK 14105", + "author": "Skowro?ski R, Fanestil DD, Beaumont K", + "citation": "Skowro?ski R, Fanestil DD, Beaumont K. Photoaffinity labeling of peripheral-type benzodiazepine receptors in rat kidney mitochondria with [3H]PK 14105. Eur J Pharmacol. 1988 Mar 29;148(2):187-93. PubMed PMID: 2837399.", + "otherId": "0", + "citationId": 68, + "otherSource": "" + } + }, + { + "aeid": 707, + "assayComponentEndpointName": "NVS_MP_rPBR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_MP_rPBR was analyzed into 1 assay endpoint. This assay endpoint, NVS_MP_rPBR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Tspo. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is cholesterol transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "PK11195", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "cholesterol transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 444, + "assayComponentName": "NVS_MP_rPBR", + "assayComponentDesc": "NVS_MP_rPBR is one of one assay component(s) measured or calculated from the NVS_MP_rPBR assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-PK11195] are indicative of a change in transporter function and kinetics for the Norway rat translocator protein [GeneSymbol:Tspo | GeneID:24230 | Uniprot_SwissProt_Accession:P16257].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-PK11195", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 258, + "assayName": "NVS_MP_rPBR", + "assayDesc": "NVS_MP_rPBR is a biochemical, single-readout assay that uses extracted gene-proteins from Rat kidney membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "kidney", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat kidney membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 382, + "geneName": "translocator protein", + "description": null, + "geneSymbol": "Tspo", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24230, + "officialSymbol": "Tspo", + "officialFullName": "translocator protein", + "uniprotAccessionNumber": "P16257" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2837399", + "pmid": 2837399, + "title": "Photoaffinity labeling of peripheral-type benzodiazepine receptors in rat kidney mitochondria with [3H]PK 14105", + "author": "Skowro?ski R, Fanestil DD, Beaumont K", + "citation": "Skowro?ski R, Fanestil DD, Beaumont K. Photoaffinity labeling of peripheral-type benzodiazepine receptors in rat kidney mitochondria with [3H]PK 14105. Eur J Pharmacol. 1988 Mar 29;148(2):187-93. PubMed PMID: 2837399.", + "otherId": "0", + "citationId": 68, + "otherSource": "" + } + }, + { + "aeid": 708, + "assayComponentEndpointName": "NVS_NR_bER", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_bER was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_bER, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene ESR1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 445, + "assayComponentName": "NVS_NR_bER", + "assayComponentDesc": "NVS_NR_bER is one of one assay component(s) measured or calculated from the NVS_NR_bER assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-estradiol] are indicative of a change in receptor function and kinetics for the cattle estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:407238 | Uniprot_SwissProt_Accession:P49884].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-estradiol", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 259, + "assayName": "NVS_NR_bER", + "assayDesc": "NVS_NR_bER is a biochemical, single-readout assay that uses extracted gene-proteins from Bovine uterine membranes in a tissue-based cell-free assay. Measurements were taken 18 hours after chemical dosing in a 96-well plate.", + "timepointHr": 18.0, + "organismId": 9913, + "organism": "bovine", + "tissue": "uterus", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Bovine uterine membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 459, + "geneName": "estrogen receptor 1", + "description": "provisional", + "geneSymbol": "ESR1", + "organismId": 4, + "trackStatus": "live", + "entrezGeneId": 407238, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P49884" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2090365", + "pmid": 2090365, + "title": "Transient elevation of estrogen receptors in the neonatal rat hippocampus", + "author": "O'Keefe JA, Handa RJ", + "citation": "O'Keefe JA, Handa RJ. Transient elevation of estrogen receptors in the neonatal rat hippocampus. Brain Res Dev Brain Res. 1990 Dec 1;57(1):119-27. PubMed PMID: 2090365.", + "otherId": "0", + "citationId": 29, + "otherSource": "" + } + }, + { + "aeid": 709, + "assayComponentEndpointName": "NVS_NR_bPR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_bPR was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_bPR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene PGR. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Promegestone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 446, + "assayComponentName": "NVS_NR_bPR", + "assayComponentDesc": "NVS_NR_bPR is one of one assay component(s) measured or calculated from the NVS_NR_bPR assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Promegestone] are indicative of a change in receptor function and kinetics for the cattle progesterone receptor-like [GeneSymbol:PGR | GeneID:100848466 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Promegestone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 260, + "assayName": "NVS_NR_bPR", + "assayDesc": "NVS_NR_bPR is a biochemical, single-readout assay that uses extracted gene-proteins from Bovine uterine membranes in a tissue-based cell-free assay. Measurements were taken 18 hours after chemical dosing in a 96-well plate.", + "timepointHr": 18.0, + "organismId": 9913, + "organism": "bovine", + "tissue": "uterus", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Bovine uterine membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 479, + "geneName": "progesterone receptor-like", + "description": "provisional", + "geneSymbol": "PGR", + "organismId": 4, + "trackStatus": "live", + "entrezGeneId": 100848466, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2419120", + "pmid": 2419120, + "title": "Binding of 7 alpha, 17 alpha-dimethyl-19-nortestosterone (mibolerone) to androgen and progesterone receptors in human and animal tissues", + "author": "Traish AM, Müller RE, Wotiz HH", + "citation": "Traish AM, Müller RE, Wotiz HH. Binding of 7 alpha, 17 alpha-dimethyl-19-nortestosterone (mibolerone) to androgen and progesterone receptors in human and animal tissues. Endocrinology. 1986 Apr;118(4):1327-33. PubMed PMID: 2419120.", + "otherId": "0", + "citationId": 48, + "otherSource": "" + } + }, + { + "aeid": 710, + "assayComponentEndpointName": "NVS_NR_cAR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_cAR was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_cAR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene AR. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methyltrienolone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 447, + "assayComponentName": "NVS_NR_cAR", + "assayComponentDesc": "NVS_NR_cAR is one of one assay component(s) measured or calculated from the NVS_NR_cAR assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-methyltrienolone] are indicative of a change in receptor function and kinetics for the chimpanzee androgen receptor [GeneSymbol:AR | GeneID:747460 | Uniprot_SwissProt_Accession:O97775].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-methyltrienolone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 261, + "assayName": "NVS_NR_cAR", + "assayDesc": "NVS_NR_cAR is a biochemical, single-readout assay that uses extracted gene-proteins from Sf9/Sf21 in a cell-free assay. Measurements were taken 72 hours after chemical dosing in a 96-well plate.", + "timepointHr": 72.0, + "organismId": 9598, + "organism": "chimpanzee", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "Sf9/Sf21", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 464, + "geneName": "androgen receptor", + "description": "provisional", + "geneSymbol": "AR", + "organismId": 7, + "trackStatus": "live", + "entrezGeneId": 747460, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "O97775" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 711, + "assayComponentEndpointName": "NVS_NR_hAR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hAR was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hAR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene AR. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methyltrienolone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 448, + "assayComponentName": "NVS_NR_hAR", + "assayComponentDesc": "NVS_NR_hAR is one of one assay component(s) measured or calculated from the NVS_NR_hAR assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-methyltrienolone] are indicative of a change in receptor function and kinetics for the human androgen receptor [GeneSymbol:AR | GeneID:367 | Uniprot_SwissProt_Accession:P10275].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-methyltrienolone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 262, + "assayName": "NVS_NR_hAR", + "assayDesc": "NVS_NR_hAR is a biochemical, single-readout assay that uses extracted gene-proteins from LnCAP in a cell-free assay. Measurements were taken 20 hours after chemical dosing in a 96-well plate.", + "timepointHr": 20.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "LnCAP", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/436741", + "pmid": 436741, + "title": "Androgen receptor assay with [3H]methyltrienolone (R1881) in the presence of progesterone receptors", + "author": "Zava DT, Landrum B, Horwitz KB, McGuire WL", + "citation": "Zava DT, Landrum B, Horwitz KB, McGuire WL. Androgen receptor assay with [3H]methyltrienolone (R1881) in the presence of progesterone receptors. Endocrinology. 1979 Apr;104(4):1007-12. PubMed PMID: 436741.", + "otherId": "0", + "citationId": 7, + "otherSource": "" + } + }, + { + "aeid": 712, + "assayComponentEndpointName": "NVS_NR_hCAR_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hCAR_Agonist was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hCAR_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene NR1I3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "CITCO", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 449, + "assayComponentName": "NVS_NR_hCAR_Agonist", + "assayComponentDesc": "NVS_NR_hCAR_Agonist is one of one assay component(s) measured or calculated from the NVS_NR_hCAR_Agonist assay. It is designed to make measurements of fluorescent resonance energy transfer, a form of binding reporter, as detected with fluorescent resonance energy transfer signals by Time-Resolved Fluorescence Resonance Energy Transfer (TR-FRET) technology.", + "assayComponentTargetDesc": "Changes to fluorescent resonance energy transfer signals produced from the binding between the key ligand and antibody reagents [Fluorescein-labeled coactivator peptide and Terbium-labeled anti-GST antibody] are indicative of a change in the receptor agonist activity for the human nuclear receptor subfamily 1, group I, member 3 [GeneSymbol:NR1I3 | GeneID:9970 | Uniprot_SwissProt_Accession:Q14994].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "fret", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "FRET: TR-FRET", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "ligand;antibody", + "keyAssayReagent": "Fluorescein-labeled coactivator peptide;Terbium-labeled anti-GST antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 263, + "assayName": "NVS_NR_hCAR_Agonist", + "assayDesc": "NVS_NR_hCAR_Agonist is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 356, + "geneName": "nuclear receptor subfamily 1, group I, member 3", + "description": null, + "geneSymbol": "NR1I3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9970, + "officialSymbol": "NR1I3", + "officialFullName": "nuclear receptor subfamily 1, group I, member 3", + "uniprotAccessionNumber": "Q14994" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12611900", + "pmid": 12611900, + "title": "Identification of a novel human constitutive androstane receptor (CAR) agonist and its use in the identification of CAR target genes", + "author": "Maglich JM, Parks DJ, Moore LB, Collins JL, Goodwin B, Billin AN, Stoltz CA, Kliewer SA, Lambert MH, Willson TM, Moore JT", + "citation": "Maglich JM, Parks DJ, Moore LB, Collins JL, Goodwin B, Billin AN, Stoltz CA, Kliewer SA, Lambert MH, Willson TM, Moore JT. Identification of a novel human constitutive androstane receptor (CAR) agonist and its use in the identification of CAR target genes. J Biol Chem. 2003 May 9;278(19):17277-83. Epub 2003 Feb 27. PubMed PMID: 12611900.", + "otherId": "0", + "citationId": 195, + "otherSource": "" + } + }, + { + "aeid": 713, + "assayComponentEndpointName": "NVS_NR_hCAR_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hCAR_Antagonist was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hCAR_Antagonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene NR1I3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Clotrimazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 450, + "assayComponentName": "NVS_NR_hCAR_Antagonist", + "assayComponentDesc": "NVS_NR_hCAR_Antagonist is one of one assay component(s) measured or calculated from the NVS_NR_hCAR_Antagonist assay. It is designed to make measurements of fluorescent resonance energy transfer, a form of binding reporter, as detected with fluorescent resonance energy transfer signals by Time-Resolved Fluorescence Resonance Energy Transfer (TR-FRET) technology.", + "assayComponentTargetDesc": "Changes to fluorescent resonance energy transfer signals produced from the binding between the key ligand and antibody reagents [Fluorescein-labeled coactivator peptide and Terbium-labeled anti-GST antibody] are indicative of a change in the receptor antagonist activity for the human nuclear receptor subfamily 1, group I, member 3 [GeneSymbol:NR1I3 | GeneID:9970 | Uniprot_SwissProt_Accession:Q14994].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "fret", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "FRET: TR-FRET", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "ligand;antibody", + "keyAssayReagent": "Fluorescein-labeled coactivator peptide;Terbium-labeled anti-GST antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 264, + "assayName": "NVS_NR_hCAR_Antagonist", + "assayDesc": "NVS_NR_hCAR_Antagonist is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 356, + "geneName": "nuclear receptor subfamily 1, group I, member 3", + "description": null, + "geneSymbol": "NR1I3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9970, + "officialSymbol": "NR1I3", + "officialFullName": "nuclear receptor subfamily 1, group I, member 3", + "uniprotAccessionNumber": "Q14994" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12611900", + "pmid": 12611900, + "title": "Identification of a novel human constitutive androstane receptor (CAR) agonist and its use in the identification of CAR target genes", + "author": "Maglich JM, Parks DJ, Moore LB, Collins JL, Goodwin B, Billin AN, Stoltz CA, Kliewer SA, Lambert MH, Willson TM, Moore JT", + "citation": "Maglich JM, Parks DJ, Moore LB, Collins JL, Goodwin B, Billin AN, Stoltz CA, Kliewer SA, Lambert MH, Willson TM, Moore JT. Identification of a novel human constitutive androstane receptor (CAR) agonist and its use in the identification of CAR target genes. J Biol Chem. 2003 May 9;278(19):17277-83. Epub 2003 Feb 27. PubMed PMID: 12611900.", + "otherId": "0", + "citationId": 195, + "otherSource": "" + } + }, + { + "aeid": 714, + "assayComponentEndpointName": "NVS_NR_hER", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hER was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hER, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene ESR1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 451, + "assayComponentName": "NVS_NR_hER", + "assayComponentDesc": "NVS_NR_hER is one of one assay component(s) measured or calculated from the NVS_NR_hER assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-estradiol] are indicative of a change in receptor function and kinetics for the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-estradiol", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 265, + "assayName": "NVS_NR_hER", + "assayDesc": "NVS_NR_hER is a biochemical, single-readout assay that uses extracted gene-proteins from MCF7 in a cell-free assay. Measurements were taken 18 hours after chemical dosing in a 96-well plate.", + "timepointHr": 18.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "MCF7", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2090365", + "pmid": 2090365, + "title": "Transient elevation of estrogen receptors in the neonatal rat hippocampus", + "author": "O'Keefe JA, Handa RJ", + "citation": "O'Keefe JA, Handa RJ. Transient elevation of estrogen receptors in the neonatal rat hippocampus. Brain Res Dev Brain Res. 1990 Dec 1;57(1):119-27. PubMed PMID: 2090365.", + "otherId": "0", + "citationId": 29, + "otherSource": "" + } + }, + { + "aeid": 715, + "assayComponentEndpointName": "NVS_NR_hFXR_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hFXR_Agonist was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hFXR_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene NR1H4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "CDCA", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 452, + "assayComponentName": "NVS_NR_hFXR_Agonist", + "assayComponentDesc": "NVS_NR_hFXR_Agonist is one of one assay component(s) measured or calculated from the NVS_NR_hFXR_Agonist assay. It is designed to make measurements of fluorescent resonance energy transfer, a form of binding reporter, as detected with fluorescent resonance energy transfer signals by Time-Resolved Fluorescence Resonance Energy Transfer (TR-FRET) technology.", + "assayComponentTargetDesc": "Changes to fluorescent resonance energy transfer signals produced from the binding between the key ligand and antibody reagents [Fluorescein-labeled coactivator peptide and Terbium-labeled anti-GST antibody] are indicative of a change in the receptor agonist activity for the human nuclear receptor subfamily 1, group H, member 4 [GeneSymbol:NR1H4 | GeneID:9971 | Uniprot_SwissProt_Accession:Q96RI1].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "fret", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "FRET: TR-FRET", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "ligand;antibody", + "keyAssayReagent": "Fluorescein-labeled coactivator peptide;Terbium-labeled anti-GST antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 266, + "assayName": "NVS_NR_hFXR_Agonist", + "assayDesc": "NVS_NR_hFXR_Agonist is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 357, + "geneName": "nuclear receptor subfamily 1, group H, member 4", + "description": null, + "geneSymbol": "NR1H4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9971, + "officialSymbol": "NR1H4", + "officialFullName": "nuclear receptor subfamily 1, group H, member 4", + "uniprotAccessionNumber": "Q96RI1" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/11988537", + "pmid": 11988537, + "title": "A natural product that lowers cholesterol as an antagonist ligand for FXR", + "author": "Urizar NL, Liverman AB, Dodds DT, Silva FV, Ordentlich P, Yan Y, Gonzalez FJ, Heyman RA, Mangelsdorf DJ, Moore DD", + "citation": "Urizar NL, Liverman AB, Dodds DT, Silva FV, Ordentlich P, Yan Y, Gonzalez FJ, Heyman RA, Mangelsdorf DJ, Moore DD. A natural product that lowers cholesterol as an antagonist ligand for FXR. Science. 2002 May 31;296(5573):1703-6. Epub 2002 May 2. PubMed PMID: 11988537.", + "otherId": "0", + "citationId": 188, + "otherSource": "" + } + }, + { + "aeid": 716, + "assayComponentEndpointName": "NVS_NR_hFXR_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hFXR_Antagonist was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hFXR_Antagonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene NR1H4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Guggulsterone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 453, + "assayComponentName": "NVS_NR_hFXR_Antagonist", + "assayComponentDesc": "NVS_NR_hFXR_Antagonist is one of one assay component(s) measured or calculated from the NVS_NR_hFXR_Antagonist assay. It is designed to make measurements of fluorescent resonance energy transfer, a form of binding reporter, as detected with fluorescent resonance energy transfer signals by Time-Resolved Fluorescence Resonance Energy Transfer (TR-FRET) technology.", + "assayComponentTargetDesc": "Changes to fluorescent resonance energy transfer signals produced from the binding between the key ligand and antibody reagents [Fluorescein-labeled coactivator peptide and Terbium-labeled anti-GST antibody] are indicative of a change in the receptor antagonist activity for the human nuclear receptor subfamily 1, group H, member 4 [GeneSymbol:NR1H4 | GeneID:9971 | Uniprot_SwissProt_Accession:Q96RI1].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "fret", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "FRET: TR-FRET", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "ligand;antibody", + "keyAssayReagent": "Fluorescein-labeled coactivator peptide;Terbium-labeled anti-GST antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 267, + "assayName": "NVS_NR_hFXR_Antagonist", + "assayDesc": "NVS_NR_hFXR_Antagonist is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 357, + "geneName": "nuclear receptor subfamily 1, group H, member 4", + "description": null, + "geneSymbol": "NR1H4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9971, + "officialSymbol": "NR1H4", + "officialFullName": "nuclear receptor subfamily 1, group H, member 4", + "uniprotAccessionNumber": "Q96RI1" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/11988537", + "pmid": 11988537, + "title": "A natural product that lowers cholesterol as an antagonist ligand for FXR", + "author": "Urizar NL, Liverman AB, Dodds DT, Silva FV, Ordentlich P, Yan Y, Gonzalez FJ, Heyman RA, Mangelsdorf DJ, Moore DD", + "citation": "Urizar NL, Liverman AB, Dodds DT, Silva FV, Ordentlich P, Yan Y, Gonzalez FJ, Heyman RA, Mangelsdorf DJ, Moore DD. A natural product that lowers cholesterol as an antagonist ligand for FXR. Science. 2002 May 31;296(5573):1703-6. Epub 2002 May 2. PubMed PMID: 11988537.", + "otherId": "0", + "citationId": 188, + "otherSource": "" + } + }, + { + "aeid": 717, + "assayComponentEndpointName": "NVS_NR_hGR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hGR was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hGR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene NR3C1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Triamcinolone acetonide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 454, + "assayComponentName": "NVS_NR_hGR", + "assayComponentDesc": "NVS_NR_hGR is one of one assay component(s) measured or calculated from the NVS_NR_hGR assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-dexamethasone] are indicative of a change in receptor function and kinetics for the human nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor) [GeneSymbol:NR3C1 | GeneID:2908 | Uniprot_SwissProt_Accession:P04150].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-dexamethasone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 268, + "assayName": "NVS_NR_hGR", + "assayDesc": "NVS_NR_hGR is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 16 hours after chemical dosing in a 96-well plate.", + "timepointHr": 16.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/8061598", + "pmid": 8061598, + "title": "Binding of [3H]triamcinolone acetonide to glucocorticoid receptors in brain cytosol fractions of rats with intact adrenals", + "author": "Han D, Ogita K, Kashiwai K, Narita S, Yoneda Y", + "citation": "Han D, Ogita K, Kashiwai K, Narita S, Yoneda Y. Binding of [3H]triamcinolone acetonide to glucocorticoid receptors in brain cytosol fractions of rats with intact adrenals. Neurochem Int. 1994 Apr;24(4):339-48. PubMed PMID: 8061598.", + "otherId": "0", + "citationId": 154, + "otherSource": "" + } + }, + { + "aeid": 718, + "assayComponentEndpointName": "NVS_NR_hPPARa", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hPPARa was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hPPARa, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene PPARA. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GW7647", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 455, + "assayComponentName": "NVS_NR_hPPARa", + "assayComponentDesc": "NVS_NR_hPPARa is one of one assay component(s) measured or calculated from the NVS_NR_hPPARa assay. It is designed to make measurements of fluorescent resonance energy transfer, a form of binding reporter, as detected with fluorescent resonance energy transfer signals by Time-Resolved Fluorescence Resonance Energy Transfer (TR-FRET) technology.", + "assayComponentTargetDesc": "Changes to fluorescent resonance energy transfer signals produced from the receptor-ligand binding of the key ligand [Fluoromone PPAR green] are indicative of a change in receptor function and kinetics for the human peroxisome proliferator-activated receptor alpha [GeneSymbol:PPARA | GeneID:5465 | Uniprot_SwissProt_Accession:Q07869].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "fret", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "FRET: TR-FRET", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "Fluoromone PPAR green", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 269, + "assayName": "NVS_NR_hPPARa", + "assayDesc": "NVS_NR_hPPARa is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 248, + "geneName": "peroxisome proliferator-activated receptor alpha", + "description": null, + "geneSymbol": "PPARA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5465, + "officialSymbol": "PPARA", + "officialFullName": "peroxisome proliferator-activated receptor alpha", + "uniprotAccessionNumber": "Q07869" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/15497675", + "pmid": 15497675, + "title": "Peroxisome proliferator-activated receptor (PPAR)-alpha: a pharmacological target with a promising future. Pharm Res", + "author": "van Raalte DH, Li M, Pritchard PH, Wasan KM", + "citation": "van Raalte DH, Li M, Pritchard PH, Wasan KM. Peroxisome proliferator-activated receptor (PPAR)-alpha: a pharmacological target with a promising future. Pharm Res. 2004 Sep;21(9):1531-8. Review. PubMed PMID: 15497675.", + "otherId": "0", + "citationId": 199, + "otherSource": "" + } + }, + { + "aeid": 719, + "assayComponentEndpointName": "NVS_NR_hPPARg", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hPPARg was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hPPARg, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene PPARG. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ciglitazone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 456, + "assayComponentName": "NVS_NR_hPPARg", + "assayComponentDesc": "NVS_NR_hPPARg is one of one assay component(s) measured or calculated from the NVS_NR_hPPARg assay. It is designed to make measurements of fluorescent polarization, a form of binding reporter, as detected with fluorescence polarization signals by Fluorescence Polarization technology.", + "assayComponentTargetDesc": "Changes to fluorescence polarization signals produced from the receptor-ligand binding of the key ligand [Fluorescent Ligand] are indicative of a change in receptor function and kinetics for the human peroxisome proliferator-activated receptor gamma [GeneSymbol:PPARG | GeneID:5468 | Uniprot_SwissProt_Accession:P37231].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "fluorescent polarization", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence polarization", + "detectionTechnology": "Fluorescence Polarization", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "Fluorescent Ligand", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 270, + "assayName": "NVS_NR_hPPARg", + "assayDesc": "NVS_NR_hPPARg is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hours after chemical dosing in a 384-well plate.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 250, + "geneName": "peroxisome proliferator-activated receptor gamma", + "description": null, + "geneSymbol": "PPARG", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5468, + "officialSymbol": "PPARG", + "officialFullName": "peroxisome proliferator-activated receptor gamma", + "uniprotAccessionNumber": "P37231" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/9744270", + "pmid": 9744270, + "title": "Ligand binding and co-activator assembly of the peroxisome proliferator-activated receptor-gamma", + "author": "Nolte RT, Wisely GB, Westin S, Cobb JE, Lambert MH, Kurokawa R, Rosenfeld MG, Willson TM, Glass CK, Milburn MV", + "citation": "Nolte RT, Wisely GB, Westin S, Cobb JE, Lambert MH, Kurokawa R, Rosenfeld MG, Willson TM, Glass CK, Milburn MV. Ligand binding and co-activator assembly of the peroxisome proliferator-activated receptor-gamma. Nature. 1998 Sep 10;395(6698):137-43. PubMed PMID: 9744270.", + "otherId": "0", + "citationId": 174, + "otherSource": "" + } + }, + { + "aeid": 720, + "assayComponentEndpointName": "NVS_NR_hPR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hPR was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hPR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene PGR. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Promegestone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 457, + "assayComponentName": "NVS_NR_hPR", + "assayComponentDesc": "NVS_NR_hPR is one of one assay component(s) measured or calculated from the NVS_NR_hPR assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Promegestone] are indicative of a change in receptor function and kinetics for the human progesterone receptor [GeneSymbol:PGR | GeneID:5241 | Uniprot_SwissProt_Accession:P06401].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Promegestone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 271, + "assayName": "NVS_NR_hPR", + "assayDesc": "NVS_NR_hPR is a biochemical, single-readout assay that uses extracted gene-proteins from T47D in a cell-free assay. Measurements were taken 18 hours after chemical dosing in a 96-well plate.", + "timepointHr": 18.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "T47D", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2419120", + "pmid": 2419120, + "title": "Binding of 7 alpha, 17 alpha-dimethyl-19-nortestosterone (mibolerone) to androgen and progesterone receptors in human and animal tissues", + "author": "Traish AM, Müller RE, Wotiz HH", + "citation": "Traish AM, Müller RE, Wotiz HH. Binding of 7 alpha, 17 alpha-dimethyl-19-nortestosterone (mibolerone) to androgen and progesterone receptors in human and animal tissues. Endocrinology. 1986 Apr;118(4):1327-33. PubMed PMID: 2419120.", + "otherId": "0", + "citationId": 48, + "otherSource": "" + } + }, + { + "aeid": 721, + "assayComponentEndpointName": "NVS_NR_hPXR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hPXR was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hPXR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene NR1I2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TO901317", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 458, + "assayComponentName": "NVS_NR_hPXR", + "assayComponentDesc": "NVS_NR_hPXR is one of one assay component(s) measured or calculated from the NVS_NR_hPXR assay. It is designed to make measurements of fluorescent resonance energy transfer, a form of binding reporter, as detected with fluorescent resonance energy transfer signals by Time-Resolved Fluorescence Resonance Energy Transfer (TR-FRET) technology.", + "assayComponentTargetDesc": "Changes to fluorescent resonance energy transfer signals produced from the receptor-ligand binding of the key ligand [Fluormone PXR (SXR) green] are indicative of a change in receptor function and kinetics for the human nuclear receptor subfamily 1, group I, member 2 [GeneSymbol:NR1I2 | GeneID:8856 | Uniprot_SwissProt_Accession:O75469].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "fret", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "FRET: TR-FRET", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "Fluormone PXR (SXR) green", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 272, + "assayName": "NVS_NR_hPXR", + "assayDesc": "NVS_NR_hPXR is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hours after chemical dosing in a 384-well plate.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 350, + "geneName": "nuclear receptor subfamily 1, group I, member 2", + "description": null, + "geneSymbol": "NR1I2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8856, + "officialSymbol": "NR1I2", + "officialFullName": "nuclear receptor subfamily 1, group I, member 2", + "uniprotAccessionNumber": "O75469" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12663745", + "pmid": 12663745, + "title": "Genetic profiling defines the xenobiotic gene network controlled by the nuclear receptor pregnane X receptor", + "author": "Rosenfeld JM, Vargas R Jr, Xie W, Evans RM", + "citation": "Rosenfeld JM, Vargas R Jr, Xie W, Evans RM. Genetic profiling defines the xenobiotic gene network controlled by the nuclear receptor pregnane X receptor. Mol Endocrinol. 2003 Jul;17(7):1268-82. Epub 2003 Mar 27. PubMed PMID: 12663745", + "otherId": "0", + "citationId": 196, + "otherSource": "" + } + }, + { + "aeid": 722, + "assayComponentEndpointName": "NVS_NR_hRAR_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hRAR_Antagonist was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hRAR_Antagonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene RARA. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "RO415253", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 459, + "assayComponentName": "NVS_NR_hRAR_Antagonist", + "assayComponentDesc": "NVS_NR_hRAR_Antagonist is one of one assay component(s) measured or calculated from the NVS_NR_hRAR_Antagonist assay. It is designed to make measurements of fluorescent resonance energy transfer, a form of binding reporter, as detected with fluorescent resonance energy transfer signals by Time-Resolved Fluorescence Resonance Energy Transfer (TR-FRET) technology.", + "assayComponentTargetDesc": "Changes to fluorescent resonance energy transfer signals produced from the binding between the key ligand and antibody reagents [Fluorescein-labeled coactivator peptide and Terbium-labeled anti-GST antibody] are indicative of a change in the receptor antagonist activity for the human retinoic acid receptor, alpha [GeneSymbol:RARA | GeneID:5914 | Uniprot_SwissProt_Accession:P10276].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "fret", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "FRET: TR-FRET", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "ligand;antibody", + "keyAssayReagent": "Fluorescein-labeled coactivator peptide;Terbium-labeled anti-GST antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 273, + "assayName": "NVS_NR_hRAR_Antagonist", + "assayDesc": "NVS_NR_hRAR_Antagonist is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hours after chemical dosing in a 384-well plate.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 279, + "geneName": "retinoic acid receptor, alpha", + "description": null, + "geneSymbol": "RARA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5914, + "officialSymbol": "RARA", + "officialFullName": "retinoic acid receptor, alpha", + "uniprotAccessionNumber": "P10276" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/10567548", + "pmid": 10567548, + "title": "Dissection of the LXXLL nuclear receptor-coactivator interaction motif using combinatorial peptide libraries: discovery of peptide antagonists of estrogen receptors alpha and beta", + "author": "Chang Cy, Norris JD, Grøn H, Paige LA, Hamilton PT, Kenan DJ, Fowlkes D, McDonnell DP", + "citation": "Chang Cy, Norris JD, Grøn H, Paige LA, Hamilton PT, Kenan DJ, Fowlkes D, McDonnell DP. Dissection of the LXXLL nuclear receptor-coactivator interaction motif using combinatorial peptide libraries: discovery of peptide antagonists of estrogen receptors alpha and beta. Mol Cell Biol. 1999 Dec;19(12):8226-39. PubMed PMID: 10567548; PubMed Central PMCID: PMC84907.", + "otherId": "0", + "citationId": 179, + "otherSource": "" + } + }, + { + "aeid": 723, + "assayComponentEndpointName": "NVS_NR_hRARa_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hRARa_Agonist was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hRARa_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene RARA. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "TTNPB", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 460, + "assayComponentName": "NVS_NR_hRARa_Agonist", + "assayComponentDesc": "NVS_NR_hRARa_Agonist is one of one assay component(s) measured or calculated from the NVS_NR_hRARa_Agonist assay. It is designed to make measurements of fluorescent resonance energy transfer, a form of binding reporter, as detected with fluorescent resonance energy transfer signals by Time-Resolved Fluorescence Resonance Energy Transfer (TR-FRET) technology.", + "assayComponentTargetDesc": "Changes to fluorescent resonance energy transfer signals produced from the binding between the key ligand and antibody reagents [Fluorescein-labeled coactivator peptide and Terbium-labeled anti-GST antibody] are indicative of a change in the receptor agonist activity for the human retinoic acid receptor, alpha [GeneSymbol:RARA | GeneID:5914 | Uniprot_SwissProt_Accession:P10276].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "fret", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "FRET: TR-FRET", + "detectionTechnology": "TR-FRET", + "keyAssayReagentType": "ligand;antibody", + "keyAssayReagent": "Fluorescein-labeled coactivator peptide;Terbium-labeled anti-GST antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 274, + "assayName": "NVS_NR_hRARa_Agonist", + "assayDesc": "NVS_NR_hRARa_Agonist is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 2 hours after chemical dosing in a 384-well plate.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 279, + "geneName": "retinoic acid receptor, alpha", + "description": null, + "geneSymbol": "RARA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5914, + "officialSymbol": "RARA", + "officialFullName": "retinoic acid receptor, alpha", + "uniprotAccessionNumber": "P10276" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/10567548", + "pmid": 10567548, + "title": "Dissection of the LXXLL nuclear receptor-coactivator interaction motif using combinatorial peptide libraries: discovery of peptide antagonists of estrogen receptors alpha and beta", + "author": "Chang Cy, Norris JD, Grøn H, Paige LA, Hamilton PT, Kenan DJ, Fowlkes D, McDonnell DP", + "citation": "Chang Cy, Norris JD, Grøn H, Paige LA, Hamilton PT, Kenan DJ, Fowlkes D, McDonnell DP. Dissection of the LXXLL nuclear receptor-coactivator interaction motif using combinatorial peptide libraries: discovery of peptide antagonists of estrogen receptors alpha and beta. Mol Cell Biol. 1999 Dec;19(12):8226-39. PubMed PMID: 10567548; PubMed Central PMCID: PMC84907.", + "otherId": "0", + "citationId": 179, + "otherSource": "" + } + }, + { + "aeid": 724, + "assayComponentEndpointName": "NVS_NR_hTRa_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_hTRa_Antagonist was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_hTRa_Antagonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene THRA. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Bisphenol A", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 461, + "assayComponentName": "NVS_NR_hTRa_Antagonist", + "assayComponentDesc": "NVS_NR_hTRa_Antagonist is one of one assay component(s) measured or calculated from the NVS_NR_hTRa_Antagonist assay. It is designed to make measurements of enzyme-linked immunosorbent assay, a form of binding reporter, as detected with chemiluminescence signals by AlphaLISA immunoassay technology.", + "assayComponentTargetDesc": "Changes to chemiluminescence signals produced from the receptor-ligand binding of the key ligand [3,3\",5-triiodo-L-thyronine] are indicative of a change in receptor antagonist activity for the human thyroid hormone receptor, alpha [GeneSymbol:THRA | GeneID:7067 | Uniprot_SwissProt_Accession:P10827].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Chemiluminescence", + "detectionTechnology": "AlphaLISA immunoassay", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "3,3\",5-triiodo-L-thyronine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 275, + "assayName": "NVS_NR_hTRa_Antagonist", + "assayDesc": "NVS_NR_hTRa_Antagonist is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 321, + "geneName": "thyroid hormone receptor, alpha", + "description": null, + "geneSymbol": "THRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7067, + "officialSymbol": "THRA", + "officialFullName": "thyroid hormone receptor, alpha", + "uniprotAccessionNumber": "P10827" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12414890", + "pmid": 12414890, + "title": "Thyroid hormone action is disrupted by bisphenol A as an antagonist", + "author": "Moriyama K, Tagami T, Akamizu T, Usui T, Saijo M, Kanamoto N, Hataya Y, Shimatsu A, Kuzuya H, Nakao K", + "citation": "Moriyama K, Tagami T, Akamizu T, Usui T, Saijo M, Kanamoto N, Hataya Y, Shimatsu A, Kuzuya H, Nakao K. Thyroid hormone action is disrupted by bisphenol A as an antagonist. J Clin Endocrinol Metab. 2002 Nov;87(11):5185-90. PubMed PMID: 12414890.", + "otherId": "0", + "citationId": 192, + "otherSource": "" + } + }, + { + "aeid": 725, + "assayComponentEndpointName": "NVS_NR_mERa", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_mERa was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_mERa, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Esr1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 462, + "assayComponentName": "NVS_NR_mERa", + "assayComponentDesc": "NVS_NR_mERa is one of one assay component(s) measured or calculated from the NVS_NR_mERa assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-estradiol] are indicative of a change in receptor function and kinetics for the house mouse estrogen receptor 1 (alpha) [GeneSymbol:Esr1 | GeneID:13982 | Uniprot_SwissProt_Accession:P19785].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-estradiol", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 276, + "assayName": "NVS_NR_mERa", + "assayDesc": "NVS_NR_mERa is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 18 hours after chemical dosing in a 96-well plate.", + "timepointHr": 18.0, + "organismId": 10090, + "organism": "mouse", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 372, + "geneName": "estrogen receptor 1 (alpha)", + "description": null, + "geneSymbol": "Esr1", + "organismId": 2, + "trackStatus": "live", + "entrezGeneId": 13982, + "officialSymbol": "Esr1", + "officialFullName": "estrogen receptor 1 (alpha)", + "uniprotAccessionNumber": "P19785" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2090365", + "pmid": 2090365, + "title": "Transient elevation of estrogen receptors in the neonatal rat hippocampus", + "author": "O'Keefe JA, Handa RJ", + "citation": "O'Keefe JA, Handa RJ. Transient elevation of estrogen receptors in the neonatal rat hippocampus. Brain Res Dev Brain Res. 1990 Dec 1;57(1):119-27. PubMed PMID: 2090365.", + "otherId": "0", + "citationId": 29, + "otherSource": "" + } + }, + { + "aeid": 726, + "assayComponentEndpointName": "NVS_NR_rAR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_rAR was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_rAR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Ar. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Methyltrienolone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 463, + "assayComponentName": "NVS_NR_rAR", + "assayComponentDesc": "NVS_NR_rAR is one of one assay component(s) measured or calculated from the NVS_NR_rAR assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-methyltrienolone] are indicative of a change in receptor function and kinetics for the Norway rat androgen receptor [GeneSymbol:Ar | GeneID:24208 | Uniprot_SwissProt_Accession:P15207].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-methyltrienolone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 277, + "assayName": "NVS_NR_rAR", + "assayDesc": "NVS_NR_rAR is a biochemical, single-readout assay that uses extracted gene-proteins from Testosterone pre-treated rat prostate in a tissue-based cell-free assay. Measurements were taken 18 hours after chemical dosing in a 96-well plate.", + "timepointHr": 18.0, + "organismId": 10116, + "organism": "rat", + "tissue": "prostate", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Testosterone pre-treated rat prostate", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 381, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "Ar", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24208, + "officialSymbol": "Ar", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P15207" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 727, + "assayComponentEndpointName": "NVS_NR_rMR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_NR_rMR was analyzed into 1 assay endpoint. This assay endpoint, NVS_NR_rMR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Nr3c2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Spironolactone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 464, + "assayComponentName": "NVS_NR_rMR", + "assayComponentDesc": "NVS_NR_rMR is one of one assay component(s) measured or calculated from the NVS_NR_rMR assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Lysate-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Aldosterone] are indicative of a change in receptor function and kinetics for the Norway rat nuclear receptor subfamily 3, group C, member 2 [GeneSymbol:Nr3c2 | GeneID:25672 | Uniprot_SwissProt_Accession:P22199].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Lysate-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Aldosterone", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 278, + "assayName": "NVS_NR_rMR", + "assayDesc": "NVS_NR_rMR is a biochemical, single-readout assay that uses extracted gene-proteins from Adrenalectomized rat brain supernatant in a tissue-based cell-free assay. Measurements were taken 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Adrenalectomized rat brain supernatant", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 413, + "geneName": "nuclear receptor subfamily 3, group C, member 2", + "description": null, + "geneSymbol": "Nr3c2", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25672, + "officialSymbol": "Nr3c2", + "officialFullName": "nuclear receptor subfamily 3, group C, member 2", + "uniprotAccessionNumber": "P22199" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/6227474", + "pmid": 6227474, + "title": "Characterization of rat brain aldosterone receptors reveals high affinity for corticosterone", + "author": "Beaumont K, Fanestil DD", + "citation": "Beaumont K, Fanestil DD. Characterization of rat brain aldosterone receptors reveals high affinity for corticosterone. Endocrinology. 1983 Dec;113(6):2043-51. PubMed PMID: 6227474.", + "otherId": "0", + "citationId": 113, + "otherSource": "" + } + }, + { + "aeid": 728, + "assayComponentEndpointName": "NVS_OR_gSIGMA_NonSelective", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_OR_gSIGMA_NonSelective was analyzed into 1 assay endpoint. This assay endpoint, NVS_OR_gSIGMA_NonSelective, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Sigmar1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the misc protein intended target family, where the subfamily is chaperone.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Haloperidol", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "misc protein", + "intendedTargetFamilySub": "chaperone", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 465, + "assayComponentName": "NVS_OR_gSIGMA_NonSelective", + "assayComponentDesc": "NVS_OR_gSIGMA_NonSelective is one of one assay component(s) measured or calculated from the NVS_OR_gSIGMA_NonSelective assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[5-3H]-(1,3-di-O-2-tolylguanidine-DI-[p-Ring-3H]] are indicative of a change in receptor function and kinetics for the domestic guinea pig sigma non-opioid intracellular receptor 1 [GeneSymbol:Sigmar1 | GeneID:100135589 | Uniprot_SwissProt_Accession:Q60492].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[5-3H]-(1,3-di-O-2-tolylguanidine-DI-[p-Ring-3H]", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 279, + "assayName": "NVS_OR_gSIGMA_NonSelective", + "assayDesc": "NVS_OR_gSIGMA_NonSelective is a biochemical, single-readout assay that uses extracted gene-proteins from Guinea pig brain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10141, + "organism": "guinea pig", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Guinea pig brain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 474, + "geneName": "sigma non-opioid intracellular receptor 1", + "description": "provisional", + "geneSymbol": "Sigmar1", + "organismId": 10, + "trackStatus": "live", + "entrezGeneId": 100135589, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "Q60492" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1675607", + "pmid": 1675607, + "title": "[3H]DTG and [3H](+)-3-PPP label pharmacologically distinct sigma binding sites in guinea pig brain membranes", + "author": "Karbon EW, Naper K, Pontecorvo MJ", + "citation": "Karbon EW, Naper K, Pontecorvo MJ. [3H]DTG and [3H](+)-3-PPP label pharmacologically distinct sigma binding sites in guinea pig brain membranes. Eur J Pharmacol. 1991 Jan 25;193(1):21-7. PubMed PMID: 1675607.", + "otherId": "0", + "citationId": 18, + "otherSource": "" + } + }, + { + "aeid": 729, + "assayComponentEndpointName": "NVS_OR_hFKBP12", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_OR_hFKBP12 was analyzed into 1 assay endpoint. This assay endpoint, NVS_OR_hFKBP12, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene FKBP1A. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the misc protein intended target family, where the subfamily is chaperone.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "FK506", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "misc protein", + "intendedTargetFamilySub": "chaperone", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 466, + "assayComponentName": "NVS_OR_hFKBP12", + "assayComponentDesc": "NVS_OR_hFKBP12 is one of one assay component(s) measured or calculated from the NVS_OR_hFKBP12 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-dihydro-FK506] are indicative of a change in enzyme function and kinetics for the human FK506 binding protein 1A, 12kDa [GeneSymbol:FKBP1A | GeneID:2280 | Uniprot_SwissProt_Accession:P62942].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-dihydro-FK506", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 280, + "assayName": "NVS_OR_hFKBP12", + "assayDesc": "NVS_OR_hFKBP12 is a biochemical, single-readout assay that uses extracted gene-proteins from E. coli in a cell-free assay. Measurements were taken 0.75 hour after chemical dosing in a 48-well plate.", + "timepointHr": 0.75, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 128, + "geneName": "FK506 binding protein 1A, 12kDa", + "description": null, + "geneSymbol": "FKBP1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2280, + "officialSymbol": "FKBP1A", + "officialFullName": "FK506 binding protein 1A, 12kDa", + "uniprotAccessionNumber": "P62942" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7685169", + "pmid": 7685169, + "title": "Detection of the FK506-FKBP-calcineurin complex by a simple binding assay", + "author": "Asami M, Kuno T, Mukai H, Tanaka C", + "citation": "Asami M, Kuno T, Mukai H, Tanaka C. Detection of the FK506-FKBP-calcineurin complex by a simple binding assay. Biochem Biophys Res Commun. 1993 May 14;192(3):1388-94. PubMed PMID: 7685169.", + "otherId": "0", + "citationId": 143, + "otherSource": "" + } + }, + { + "aeid": 730, + "assayComponentEndpointName": "NVS_TR_gDAT", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_TR_gDAT was analyzed into 1 assay endpoint. This assay endpoint, NVS_TR_gDAT, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Slc6a3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is neurotransmitter transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GBR-12909", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "neurotransmitter transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 467, + "assayComponentName": "NVS_TR_gDAT", + "assayComponentDesc": "NVS_TR_gDAT is one of one assay component(s) measured or calculated from the NVS_TR_gDAT assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-WIN,35,428] are indicative of a change in transporter function and kinetics for the domestic guinea pig solute carrier family 6 (neurotransmitter transporter, dopamine), member 3 [GeneSymbol:Slc6a3 | GeneID:100714898 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-WIN,35,428", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 281, + "assayName": "NVS_TR_gDAT", + "assayDesc": "NVS_TR_gDAT is a biochemical, single-readout assay that uses extracted gene-proteins from Guinea pig striatal membranes in a tissue-based cell-free assay. Measurements were taken 2 hours after chemical dosing in a 48-well plate.", + "timepointHr": 2.0, + "organismId": 10141, + "organism": "guinea pig", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Guinea pig striatal membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 478, + "geneName": "solute carrier family 6 (neurotransmitter transporter, dopamine), member 3", + "description": "model", + "geneSymbol": "Slc6a3", + "organismId": 10, + "trackStatus": "live", + "entrezGeneId": 100714898, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2811854", + "pmid": 2811854, + "title": "Cocaine receptors labeled by [3H]2 beta-carbomethoxy-3 beta-(4-fluorophenyl)tropane", + "author": "Madras BK, Spealman RD, Fahey MA, Neumeyer JL, Saha JK, Milius RA", + "citation": "Madras BK, Spealman RD, Fahey MA, Neumeyer JL, Saha JK, Milius RA. Cocaine receptors labeled by [3H]2 beta-carbomethoxy-3 beta-(4-fluorophenyl)tropane. Mol Pharmacol. 1989 Oct;36(4):518-24. PubMed PMID: 2811854.", + "otherId": "0", + "citationId": 65, + "otherSource": "" + } + }, + { + "aeid": 731, + "assayComponentEndpointName": "NVS_TR_hAdoT", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_TR_hAdoT was analyzed into 1 assay endpoint. This assay endpoint, NVS_TR_hAdoT, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene SLC29A1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is nucleoside transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Nitrobenzylthioinosine (NBTI)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "nucleoside transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 468, + "assayComponentName": "NVS_TR_hAdoT", + "assayComponentDesc": "NVS_TR_hAdoT is one of one assay component(s) measured or calculated from the NVS_TR_hAdoT assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Nitrobenzylthioinosine] are indicative of a change in transporter function and kinetics for the human solute carrier family 29 (equilibrative nucleoside transporter), member 1 [GeneSymbol:SLC29A1 | GeneID:2030 | Uniprot_SwissProt_Accession:Q99808].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Nitrobenzylthioinosine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 282, + "assayName": "NVS_TR_hAdoT", + "assayDesc": "NVS_TR_hAdoT is a biochemical, single-readout assay that uses extracted gene-proteins from U937 in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "U937", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 112, + "geneName": "solute carrier family 29 (equilibrative nucleoside transporter), member 1", + "description": null, + "geneSymbol": "SLC29A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2030, + "officialSymbol": "SLC29A1", + "officialFullName": "solute carrier family 29 (equilibrative nucleoside transporter), member 1", + "uniprotAccessionNumber": "Q99808" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7086410", + "pmid": 7086410, + "title": "[3H]nitrobenzylthioinosine binding as a probe for the study of adenosine uptake sites in brain", + "author": "Marangos PJ, Patel J, Clark-Rosenberg R, Martino AM", + "citation": "Marangos PJ, Patel J, Clark-Rosenberg R, Martino AM. [3H]nitrobenzylthioinosine binding as a probe for the study of adenosine uptake sites in brain. J Neurochem. 1982 Jul;39(1):184-91. PubMed PMID: 7086410.", + "otherId": "0", + "citationId": 132, + "otherSource": "" + } + }, + { + "aeid": 113, + "assayComponentEndpointName": "ATG_VDRE_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_VDRE_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_VDRE_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene VDR. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 82, + "assayComponentName": "ATG_VDRE_CIS", + "assayComponentDesc": "ATG_VDRE_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene response element VDRE, which is responsive to the endogenous human vitamin D (1,25- dihydroxyvitamin D3) receptor [GeneSymbol:VDR | GeneID:7421 | Uniprot_SwissProt_Accession:P11473].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "VDRE RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 335, + "geneName": "vitamin D (1,25- dihydroxyvitamin D3) receptor", + "description": null, + "geneSymbol": "VDR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7421, + "officialSymbol": "VDR", + "officialFullName": "vitamin D (1,25- dihydroxyvitamin D3) receptor", + "uniprotAccessionNumber": "P11473" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 114, + "assayComponentEndpointName": "ATG_Xbp1_CIS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_Xbp1_CIS was analyzed into 1 assay endpoint. \n\nThis assay endpoint, ATG_Xbp1_CIS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \n\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene XBP1. \n\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \n\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 83, + "assayComponentName": "ATG_Xbp1_CIS", + "assayComponentDesc": "ATG_Xbp1_CIS is one of 52 assay component(s) measured or calculated from the ATG_CIS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the cis-acting reporter gene Xbp1, which is responsive to the endogenous human X-box binding protein 1 [GeneSymbol:XBP1 | GeneID:7494 | Uniprot_SwissProt_Accession:P17861].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "Xbp1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 5, + "assayName": "ATG_CIS", + "assayDesc": "ATG_CIS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 337, + "geneName": "X-box binding protein 1", + "description": null, + "geneSymbol": "XBP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7494, + "officialSymbol": "XBP1", + "officialFullName": "X-box binding protein 1", + "uniprotAccessionNumber": "P17861" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 115, + "assayComponentEndpointName": "ATG_AR_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_AR_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_AR_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene AR. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "6a-Fluorotestosterone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 84, + "assayComponentName": "ATG_AR_TRANS", + "assayComponentDesc": "ATG_AR_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-AR, also known as human androgen receptor [GeneSymbol:AR | GeneID:367 | Uniprot_SwissProt_Accession:P10275].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-AR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 116, + "assayComponentEndpointName": "ATG_CAR_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_CAR_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_CAR_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR1I3. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 85, + "assayComponentName": "ATG_CAR_TRANS", + "assayComponentDesc": "ATG_CAR_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-CAR, also known as human nuclear receptor subfamily 1, group I, member 3 [GeneSymbol:NR1I3 | GeneID:9970 | Uniprot_SwissProt_Accession:Q14994].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-CAR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 356, + "geneName": "nuclear receptor subfamily 1, group I, member 3", + "description": null, + "geneSymbol": "NR1I3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9970, + "officialSymbol": "NR1I3", + "officialFullName": "nuclear receptor subfamily 1, group I, member 3", + "uniprotAccessionNumber": "Q14994" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 117, + "assayComponentEndpointName": "ATG_ERa_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_ERa_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_ERa_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ESR1. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 86, + "assayComponentName": "ATG_ERa_TRANS", + "assayComponentDesc": "ATG_ERa_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-ERa, also known as human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-ERa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 118, + "assayComponentEndpointName": "ATG_ERRa_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_ERRa_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_ERRa_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ESRRA. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 87, + "assayComponentName": "ATG_ERRa_TRANS", + "assayComponentDesc": "ATG_ERRa_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-ERRa, also known as human estrogen-related receptor alpha [GeneSymbol:ESRRA | GeneID:2101 | Uniprot_SwissProt_Accession:P11474].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-ERRa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 119, + "geneName": "estrogen-related receptor alpha", + "description": null, + "geneSymbol": "ESRRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2101, + "officialSymbol": "ESRRA", + "officialFullName": "estrogen-related receptor alpha", + "uniprotAccessionNumber": "P11474" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 119, + "assayComponentEndpointName": "ATG_ERRg_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_ERRg_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_ERRg_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene ESRRG. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 88, + "assayComponentName": "ATG_ERRg_TRANS", + "assayComponentDesc": "ATG_ERRg_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-ERRg, also known as human estrogen-related receptor gamma [GeneSymbol:ESRRG | GeneID:2104 | Uniprot_SwissProt_Accession:P62508].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-ERRg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 121, + "geneName": "estrogen-related receptor gamma", + "description": null, + "geneSymbol": "ESRRG", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2104, + "officialSymbol": "ESRRG", + "officialFullName": "estrogen-related receptor gamma", + "uniprotAccessionNumber": "P62508" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 120, + "assayComponentEndpointName": "ATG_FXR_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_FXR_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_FXR_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR1H4. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "CDCA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 89, + "assayComponentName": "ATG_FXR_TRANS", + "assayComponentDesc": "ATG_FXR_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-FXR, also known as human nuclear receptor subfamily 1, group H, member 4 [GeneSymbol:NR1H4 | GeneID:9971 | Uniprot_SwissProt_Accession:Q96RI1].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-FXR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 357, + "geneName": "nuclear receptor subfamily 1, group H, member 4", + "description": null, + "geneSymbol": "NR1H4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9971, + "officialSymbol": "NR1H4", + "officialFullName": "nuclear receptor subfamily 1, group H, member 4", + "uniprotAccessionNumber": "Q96RI1" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 121, + "assayComponentEndpointName": "ATG_GAL4_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_GAL4_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_GAL4_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \r\n\r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is baseline control.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 90, + "assayComponentName": "ATG_GAL4_TRANS", + "assayComponentDesc": "ATG_GAL4_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-gal4, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-gal4 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 466, + "geneName": "Gal4p", + "description": "provisional", + "geneSymbol": "GAL4", + "organismId": 8, + "trackStatus": "live", + "entrezGeneId": 855828, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P04386" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 122, + "assayComponentEndpointName": "ATG_GR_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_GR_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_GR_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR3C1. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 91, + "assayComponentName": "ATG_GR_TRANS", + "assayComponentDesc": "ATG_GR_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-GR, also known as human nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor) [GeneSymbol:NR3C1 | GeneID:2908 | Uniprot_SwissProt_Accession:P04150].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-GR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 123, + "assayComponentEndpointName": "ATG_HNF4a_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_HNF4a_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_HNF4a_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene HNF4A. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 92, + "assayComponentName": "ATG_HNF4a_TRANS", + "assayComponentDesc": "ATG_HNF4a_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-HNF4a, also known as human hepatocyte nuclear factor 4, alpha [GeneSymbol:HNF4A | GeneID:3172 | Uniprot_SwissProt_Accession:P41235].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-HNF4a RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 157, + "geneName": "hepatocyte nuclear factor 4, alpha", + "description": null, + "geneSymbol": "HNF4A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3172, + "officialSymbol": "HNF4A", + "officialFullName": "hepatocyte nuclear factor 4, alpha", + "uniprotAccessionNumber": "P41235" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 124, + "assayComponentEndpointName": "ATG_Hpa5_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_Hpa5_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_Hpa5_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \r\n\r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 93, + "assayComponentName": "ATG_Hpa5_TRANS", + "assayComponentDesc": "ATG_Hpa5_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-Hpa5, which is used as a basal promoter.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-Hpa5 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 125, + "assayComponentEndpointName": "ATG_LXRa_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_LXRa_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_LXRa_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR1H3. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "T0901317", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 94, + "assayComponentName": "ATG_LXRa_TRANS", + "assayComponentDesc": "ATG_LXRa_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-LXRa, also known as human nuclear receptor subfamily 1, group H, member 3 [GeneSymbol:NR1H3 | GeneID:10062 | Uniprot_SwissProt_Accession:Q13133].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-LXRa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 363, + "geneName": "nuclear receptor subfamily 1, group H, member 3", + "description": null, + "geneSymbol": "NR1H3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10062, + "officialSymbol": "NR1H3", + "officialFullName": "nuclear receptor subfamily 1, group H, member 3", + "uniprotAccessionNumber": "Q13133" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 126, + "assayComponentEndpointName": "ATG_LXRb_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_LXRb_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_LXRb_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR1H2. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "T0901317", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 95, + "assayComponentName": "ATG_LXRb_TRANS", + "assayComponentDesc": "ATG_LXRb_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-LXRb, also known as human nuclear receptor subfamily 1, group H, member 2 [GeneSymbol:NR1H2 | GeneID:7376 | Uniprot_SwissProt_Accession:P55055].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-LXRb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 332, + "geneName": "nuclear receptor subfamily 1, group H, member 2", + "description": null, + "geneSymbol": "NR1H2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7376, + "officialSymbol": "NR1H2", + "officialFullName": "nuclear receptor subfamily 1, group H, member 2", + "uniprotAccessionNumber": "P55055" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 127, + "assayComponentEndpointName": "ATG_M_06_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_M_06_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_M_06_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \r\n\r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 96, + "assayComponentName": "ATG_M_06_TRANS", + "assayComponentDesc": "ATG_M_06_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_06, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-M_06 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 128, + "assayComponentEndpointName": "ATG_M_19_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_M_19_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_M_19_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \r\n\r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 97, + "assayComponentName": "ATG_M_19_TRANS", + "assayComponentDesc": "ATG_M_19_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_19, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-M_19 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 129, + "assayComponentEndpointName": "ATG_M_32_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_M_32_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_M_32_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \r\n\r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 98, + "assayComponentName": "ATG_M_32_TRANS", + "assayComponentDesc": "ATG_M_32_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_32, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-M_32 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 130, + "assayComponentEndpointName": "ATG_M_61_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_M_61_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_M_61_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the background control at the transcription factor-level as they relate to the gene . \r\n\r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is internal marker.", + "assayFunctionType": "background control", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "internal marker", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 99, + "assayComponentName": "ATG_M_61_TRANS", + "assayComponentDesc": "ATG_M_61_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-M_61, which is used as an internal marker.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-M_61 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 131, + "assayComponentEndpointName": "ATG_NURR1_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_NURR1_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_NURR1_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR4A2. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 100, + "assayComponentName": "ATG_NURR1_TRANS", + "assayComponentDesc": "ATG_NURR1_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-NURR1, also known as human nuclear receptor subfamily 4, group A, member 2 [GeneSymbol:NR4A2 | GeneID:4929 | Uniprot_SwissProt_Accession:P43354].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-NURR1 RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 224, + "geneName": "nuclear receptor subfamily 4, group A, member 2", + "description": null, + "geneSymbol": "NR4A2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4929, + "officialSymbol": "NR4A2", + "officialFullName": "nuclear receptor subfamily 4, group A, member 2", + "uniprotAccessionNumber": "P43354" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 132, + "assayComponentEndpointName": "ATG_PPARa_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_PPARa_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_PPARa_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARA. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "GW0742", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 101, + "assayComponentName": "ATG_PPARa_TRANS", + "assayComponentDesc": "ATG_PPARa_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-PPARa, also known as human peroxisome proliferator-activated receptor alpha [GeneSymbol:PPARA | GeneID:5465 | Uniprot_SwissProt_Accession:Q07869].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-PPARa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 248, + "geneName": "peroxisome proliferator-activated receptor alpha", + "description": null, + "geneSymbol": "PPARA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5465, + "officialSymbol": "PPARA", + "officialFullName": "peroxisome proliferator-activated receptor alpha", + "uniprotAccessionNumber": "Q07869" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 133, + "assayComponentEndpointName": "ATG_PPARd_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_PPARd_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_PPARd_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARD. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "GW7647", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 102, + "assayComponentName": "ATG_PPARd_TRANS", + "assayComponentDesc": "ATG_PPARd_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-PPARd, also known as human peroxisome proliferator-activated receptor delta [GeneSymbol:PPARD | GeneID:5467 | Uniprot_SwissProt_Accession:Q03181].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-PPARd RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 249, + "geneName": "peroxisome proliferator-activated receptor delta", + "description": null, + "geneSymbol": "PPARD", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5467, + "officialSymbol": "PPARD", + "officialFullName": "peroxisome proliferator-activated receptor delta", + "uniprotAccessionNumber": "Q03181" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 134, + "assayComponentEndpointName": "ATG_PPARg_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_PPARg_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_PPARg_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene PPARG. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Rosiglitazone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 103, + "assayComponentName": "ATG_PPARg_TRANS", + "assayComponentDesc": "ATG_PPARg_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-PPARg, also known as human peroxisome proliferator-activated receptor gamma [GeneSymbol:PPARG | GeneID:5468 | Uniprot_SwissProt_Accession:P37231].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-PPARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 250, + "geneName": "peroxisome proliferator-activated receptor gamma", + "description": null, + "geneSymbol": "PPARG", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5468, + "officialSymbol": "PPARG", + "officialFullName": "peroxisome proliferator-activated receptor gamma", + "uniprotAccessionNumber": "P37231" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 135, + "assayComponentEndpointName": "ATG_PXR_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_PXR_TRANS was analyzed into 1 assay endpoint. This assay endpoint, ATG_PXR_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene NR1I2. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "T0901317", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 104, + "assayComponentName": "ATG_PXR_TRANS", + "assayComponentDesc": "ATG_PXR_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-PXR, also known as human nuclear receptor subfamily 1, group I, member 2 [GeneSymbol:NR1I2 | GeneID:8856 | Uniprot_SwissProt_Accession:O75469].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-PXR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 350, + "geneName": "nuclear receptor subfamily 1, group I, member 2", + "description": null, + "geneSymbol": "NR1I2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8856, + "officialSymbol": "NR1I2", + "officialFullName": "nuclear receptor subfamily 1, group I, member 2", + "uniprotAccessionNumber": "O75469" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 136, + "assayComponentEndpointName": "ATG_RARa_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_RARa_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_RARa_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RARA. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Retinoic Acid", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 105, + "assayComponentName": "ATG_RARa_TRANS", + "assayComponentDesc": "ATG_RARa_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-RARa, also known as human retinoic acid receptor, alpha [GeneSymbol:RARA | GeneID:5914 | Uniprot_SwissProt_Accession:P10276].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-RARa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 279, + "geneName": "retinoic acid receptor, alpha", + "description": null, + "geneSymbol": "RARA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5914, + "officialSymbol": "RARA", + "officialFullName": "retinoic acid receptor, alpha", + "uniprotAccessionNumber": "P10276" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 137, + "assayComponentEndpointName": "ATG_RARb_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_RARb_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_RARb_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RARB. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Retinoic Acid", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 106, + "assayComponentName": "ATG_RARb_TRANS", + "assayComponentDesc": "ATG_RARb_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-RARb, also known as human retinoic acid receptor, beta [GeneSymbol:RARB | GeneID:5915 | Uniprot_SwissProt_Accession:P10826].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-RARb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 280, + "geneName": "retinoic acid receptor, beta", + "description": null, + "geneSymbol": "RARB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5915, + "officialSymbol": "RARB", + "officialFullName": "retinoic acid receptor, beta", + "uniprotAccessionNumber": "P10826" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 138, + "assayComponentEndpointName": "ATG_RARg_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_RARg_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_RARg_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RARG. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Retinoic Acid", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 107, + "assayComponentName": "ATG_RARg_TRANS", + "assayComponentDesc": "ATG_RARg_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-RARg, also known as human retinoic acid receptor, gamma [GeneSymbol:RARG | GeneID:5916 | Uniprot_SwissProt_Accession:P13631].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-RARg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 281, + "geneName": "retinoic acid receptor, gamma", + "description": null, + "geneSymbol": "RARG", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5916, + "officialSymbol": "RARG", + "officialFullName": "retinoic acid receptor, gamma", + "uniprotAccessionNumber": "P13631" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 139, + "assayComponentEndpointName": "ATG_RORb_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_RORb_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_RORb_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RORB. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 108, + "assayComponentName": "ATG_RORb_TRANS", + "assayComponentDesc": "ATG_RORb_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-RORb, also known as human RAR-related orphan receptor B [GeneSymbol:RORB | GeneID:6096 | Uniprot_SwissProt_Accession:Q92753].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-RORb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 285, + "geneName": "RAR-related orphan receptor B", + "description": null, + "geneSymbol": "RORB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6096, + "officialSymbol": "RORB", + "officialFullName": "RAR-related orphan receptor B", + "uniprotAccessionNumber": "Q92753" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 140, + "assayComponentEndpointName": "ATG_RORg_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_RORg_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_RORg_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RORC. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is orphan.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "NA", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "orphan", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 109, + "assayComponentName": "ATG_RORg_TRANS", + "assayComponentDesc": "ATG_RORg_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-RORg, also known as human RAR-related orphan receptor C [GeneSymbol:RORC | GeneID:6097 | Uniprot_SwissProt_Accession:P51449].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-RORg RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 286, + "geneName": "RAR-related orphan receptor C", + "description": null, + "geneSymbol": "RORC", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6097, + "officialSymbol": "RORC", + "officialFullName": "RAR-related orphan receptor C", + "uniprotAccessionNumber": "P51449" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 141, + "assayComponentEndpointName": "ATG_RXRa_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_RXRa_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_RXRa_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RXRA. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "9-cis-Retinoic acid", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 110, + "assayComponentName": "ATG_RXRa_TRANS", + "assayComponentDesc": "ATG_RXRa_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-RXRa, also known as human retinoid X receptor, alpha [GeneSymbol:RXRA | GeneID:6256 | Uniprot_SwissProt_Accession:P19793].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-RXRa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 287, + "geneName": "retinoid X receptor, alpha", + "description": null, + "geneSymbol": "RXRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6256, + "officialSymbol": "RXRA", + "officialFullName": "retinoid X receptor, alpha", + "uniprotAccessionNumber": "P19793" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 142, + "assayComponentEndpointName": "ATG_RXRb_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_RXRb_TRANS was analyzed into 1 assay endpoint. This assay endpoint, ATG_RXRb_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene RXRB. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "9-cis-Retinoic acid", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 111, + "assayComponentName": "ATG_RXRb_TRANS", + "assayComponentDesc": "ATG_RXRb_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-RXRb, also known as human retinoid X receptor, beta [GeneSymbol:RXRB | GeneID:6257 | Uniprot_SwissProt_Accession:P28702].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-RXRb RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 288, + "geneName": "retinoid X receptor, beta", + "description": null, + "geneSymbol": "RXRB", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6257, + "officialSymbol": "RXRB", + "officialFullName": "retinoid X receptor, beta", + "uniprotAccessionNumber": "P28702" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 143, + "assayComponentEndpointName": "ATG_THRa1_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_THRa1_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_THRa1_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene THRA. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "T3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 112, + "assayComponentName": "ATG_THRa1_TRANS", + "assayComponentDesc": "ATG_THRa1_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-THRa, also known as human thyroid hormone receptor, alpha [GeneSymbol:THRA | GeneID:7067 | Uniprot_SwissProt_Accession:P10827].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-THRa RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 321, + "geneName": "thyroid hormone receptor, alpha", + "description": null, + "geneSymbol": "THRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7067, + "officialSymbol": "THRA", + "officialFullName": "thyroid hormone receptor, alpha", + "uniprotAccessionNumber": "P10827" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 144, + "assayComponentEndpointName": "ATG_VDR_TRANS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component ATG_VDR_TRANS was analyzed into 1 assay endpoint. \r\n\r\nThis assay endpoint, ATG_VDR_TRANS, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\n\r\nUsing a type of inducible reporter, measures of mRNA for gain-of-signal activity can be used to understand the reporter gene at the transcription factor-level as they relate to the gene VDR. \r\n\r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a reporter gene function. \r\n\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "1a,25-Dihydroxyvitamin D3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transcription factor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 113, + "assayComponentName": "ATG_VDR_TRANS", + "assayComponentDesc": "ATG_VDR_TRANS is one of 30 assay component(s) measured or calculated from the ATG_TRANS assay. It is designed to make measurements of mRNA induction, a form of inducible reporter, as detected with fluorescence intensity signals by Reverse transcription polymerase chain reaction (RT-PCR) and Capillary electrophoresis technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of inducible changes in transcription factor activity. This is quantified by the level of mRNA reporter sequence unique to the transfected trans-acting reporter gene and exogenous transcription factor GAL4-VDR, also known as human vitamin D (1,25- dihydroxyvitamin D3) receptor [GeneSymbol:VDR | GeneID:7421 | Uniprot_SwissProt_Accession:P11473].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "RT-PCR and Capillary electrophoresis", + "keyAssayReagentType": "inducer", + "keyAssayReagent": "GAL4-VDR RTU", + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 6, + "assayName": "ATG_TRANS", + "assayDesc": "ATG_TRANS is a cell-based, multiplexed-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 24-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 24-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 3, + "assaySourceName": "ATG", + "assaySourceLongName": "Attagene", + "assaySourceDesc": "Attagene Inc. is a Contract Research Organization (CRO) offering a unique screening service using its proprietary multiplexed pathway profiling platform, the FACTORIAL.", + "gene": { + "geneId": 335, + "geneName": "vitamin D (1,25- dihydroxyvitamin D3) receptor", + "description": null, + "geneSymbol": "VDR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7421, + "officialSymbol": "VDR", + "officialFullName": "vitamin D (1,25- dihydroxyvitamin D3) receptor", + "uniprotAccessionNumber": "P11473" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/nmeth.1186", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/18297081", + "pmid": 18297081, + "title": "Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors", + "author": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S", + "citation": "Romanov S, Medvedev A, Gambarian M, Poltoratskaya N, Moeser M, Medvedeva L, Gambarian M, Diatchenko L, Makarov S. Homogeneous reporter system enables quantitative functional assessment of multiple transcription factors. Nat Methods. 2008 Mar;5(3):253-60. doi: 10.1038/nmeth.1186. Epub 2008 Feb 24. PubMed PMID: 18297081.", + "otherId": "0", + "citationId": 211, + "otherSource": "" + } + }, + { + "aeid": 146, + "assayComponentEndpointName": "BSK_3C_Eselectin", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3C_Eselectin was analyzed into 1 assay endpoint. This assay endpoint, BSK_3C_Eselectin, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene SELE. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is selectins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "selectins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 114, + "assayComponentName": "BSK_3C_Eselectin", + "assayComponentDesc": "BSK_3C_Eselectin is an assay component measured in the BSK_3C assay. It measures E-selectin antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "E-selectin antibody is used to tag and quantify the level of selectin E protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:SELE | GeneID:6401 | Uniprot_SwissProt_Accession:P16581].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "E-selectin antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 293, + "geneName": "selectin E", + "description": null, + "geneSymbol": "SELE", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6401, + "officialSymbol": "SELE", + "officialFullName": "selectin E", + "uniprotAccessionNumber": "P16581" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 148, + "assayComponentEndpointName": "BSK_3C_HLADR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3C_HLADR was analyzed into 1 assay endpoint. This assay endpoint, BSK_3C_HLADR, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene HLA-DRA. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is MHC Class II.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "MHC Class II", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 115, + "assayComponentName": "BSK_3C_HLADR", + "assayComponentDesc": "BSK_3C_HLADR is an assay component measured in the BSK_3C assay. It measures HLA-DR antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "HLA-DR antibody is used to tag and quantify the level of major histocompatibility complex, class II, DR alpha protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:HLA-DRA | GeneID:3122 | Uniprot_SwissProt_Accession:P01903].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "HLA-DR antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 153, + "geneName": "major histocompatibility complex, class II, DR alpha", + "description": null, + "geneSymbol": "HLA-DRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3122, + "officialSymbol": "HLA-DRA", + "officialFullName": "major histocompatibility complex, class II, DR alpha", + "uniprotAccessionNumber": "P01903" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 150, + "assayComponentEndpointName": "BSK_3C_ICAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3C_ICAM1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_3C_ICAM1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene ICAM1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is Immunoglobulin CAM.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 116, + "assayComponentName": "BSK_3C_ICAM1", + "assayComponentDesc": "BSK_3C_ICAM1 is an assay component measured in the BSK_3C assay. It measures ICAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "ICAM-1 antibody is used to tag and quantify the level of intercellular adhesion molecule 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:ICAM1 | GeneID:3383 | Uniprot_SwissProt_Accession:P05362].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "ICAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 170, + "geneName": "intercellular adhesion molecule 1", + "description": null, + "geneSymbol": "ICAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3383, + "officialSymbol": "ICAM1", + "officialFullName": "intercellular adhesion molecule 1", + "uniprotAccessionNumber": "P05362" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 152, + "assayComponentEndpointName": "BSK_3C_IL8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3C_IL8 was analyzed into 1 assay endpoint. This assay endpoint, BSK_3C_IL8, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL8. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is interleukins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 117, + "assayComponentName": "BSK_3C_IL8", + "assayComponentDesc": "BSK_3C_IL8 is an assay component measured in the BSK_3C assay. It measures IL-8 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "IL-8 antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 8 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:CXCL8 | GeneID:3576 | Uniprot_SwissProt_Accession:P10145].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-8 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 177, + "geneName": "chemokine (C-X-C motif) ligand 8", + "description": null, + "geneSymbol": "CXCL8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3576, + "officialSymbol": "CXCL8", + "officialFullName": "chemokine (C-X-C motif) ligand 8", + "uniprotAccessionNumber": "P10145" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 154, + "assayComponentEndpointName": "BSK_3C_MCP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3C_MCP1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_3C_MCP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CCL2. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 118, + "assayComponentName": "BSK_3C_MCP1", + "assayComponentDesc": "BSK_3C_MCP1 is an assay component measured in the BSK_3C assay. It measures MCP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MCP-1 antibody is used to tag and quantify the level of chemokine (C-C motif) ligand 2 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:CCL2 | GeneID:6347 | Uniprot_SwissProt_Accession:P13500].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MCP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 291, + "geneName": "chemokine (C-C motif) ligand 2", + "description": null, + "geneSymbol": "CCL2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6347, + "officialSymbol": "CCL2", + "officialFullName": "chemokine (C-C motif) ligand 2", + "uniprotAccessionNumber": "P13500" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 156, + "assayComponentEndpointName": "BSK_3C_MIG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3C_MIG was analyzed into 1 assay endpoint. This assay endpoint, BSK_3C_MIG, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL9. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 119, + "assayComponentName": "BSK_3C_MIG", + "assayComponentDesc": "BSK_3C_MIG is an assay component measured in the BSK_3C assay. It measures MIG antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MIG antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 9 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:CXCL9 | GeneID:4283 | Uniprot_SwissProt_Accession:Q07325].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MIG antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 201, + "geneName": "chemokine (C-X-C motif) ligand 9", + "description": null, + "geneSymbol": "CXCL9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4283, + "officialSymbol": "CXCL9", + "officialFullName": "chemokine (C-X-C motif) ligand 9", + "uniprotAccessionNumber": "Q07325" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 158, + "assayComponentEndpointName": "BSK_3C_Proliferation", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3C_Proliferation was analyzed into 1 assay endpoint. \nThis assay endpoint, BSK_3C_Proliferation, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of total protein for gain or loss-of-signal activity can be used to understand the viability at the cellular-level. \nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is proliferation.", + "assayFunctionType": "viability", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 120, + "assayComponentName": "BSK_3C_Proliferation", + "assayComponentDesc": "BSK_3C_Proliferation is an assay component measured in the BSK_3C assay. It measures 0.1% sulforhodamine related to cell proliferation using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "Proliferation in the 3C system is a measure of endothelial cell profliferation which is important to the process of wound healing and angiogensis.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 160, + "assayComponentEndpointName": "BSK_3C_SRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3C_SRB was analyzed into 1 assay endpoint. This assay endpoint, BSK_3C_SRB, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is cell conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 121, + "assayComponentName": "BSK_3C_SRB", + "assayComponentDesc": "BSK_3C_SRB is an assay component measured in the BSK_3C assay. It measures 0.1% sulforhodamine related to cell death using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "SRB in the 3C system is a measure of the total protein content of venular endothelial cells. Cell viability of adherent cells is measured by Sulforhodamine B (SRB) staining, a method that determines cell density by measuring total protein content of test wells.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 162, + "assayComponentEndpointName": "BSK_3C_Thrombomodulin", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3C_Thrombomodulin was analyzed into 1 assay endpoint. This assay endpoint, BSK_3C_Thrombomodulin, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene THBD. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 122, + "assayComponentName": "BSK_3C_Thrombomodulin", + "assayComponentDesc": "BSK_3C_Thrombomodulin is an assay component measured in the BSK_3C assay. It measures Thrombomodulin antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Thrombomodulin antibody is used to tag and quantify the level of thrombomodulin protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:THBD | GeneID:7056 | Uniprot_SwissProt_Accession:P07204].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Thrombomodulin antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 320, + "geneName": "thrombomodulin", + "description": null, + "geneSymbol": "THBD", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7056, + "officialSymbol": "THBD", + "officialFullName": "thrombomodulin", + "uniprotAccessionNumber": "P07204" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 164, + "assayComponentEndpointName": "BSK_3C_TissueFactor", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3C_TissueFactor was analyzed into 1 assay endpoint. This assay endpoint, BSK_3C_TissueFactor, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene F3. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is coagulation factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "coagulation factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 123, + "assayComponentName": "BSK_3C_TissueFactor", + "assayComponentDesc": "BSK_3C_TissueFactor is an assay component measured in the BSK_3C assay. It measures Tissue Factor antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Tissue Factor antibody is used to tag and quantify the level of coagulation factor III (thromboplastin, tissue factor) protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:F3 | GeneID:2152 | Uniprot_SwissProt_Accession:P13726].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Tissue Factor antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 123, + "geneName": "coagulation factor III (thromboplastin, tissue factor)", + "description": null, + "geneSymbol": "F3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2152, + "officialSymbol": "F3", + "officialFullName": "coagulation factor III (thromboplastin, tissue factor)", + "uniprotAccessionNumber": "P13726" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 166, + "assayComponentEndpointName": "BSK_3C_uPAR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3CAR was analyzed into 1 assay endpoint. This assay endpoint, BSK_3CAR, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene PLAUR. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is plasmogen activator.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "plasmogen activator", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 124, + "assayComponentName": "BSK_3C_uPAR", + "assayComponentDesc": "BSK_3CAR is an assay component measured in the BSK_3C assay. It measures uPAR antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "uPAR antibody is used to tag and quantify the level of plasminogen activator, urokinase receptor protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:PLAUR | GeneID:5329 | Uniprot_SwissProt_Accession:Q03405].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "uPAR antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 241, + "geneName": "plasminogen activator, urokinase receptor", + "description": null, + "geneSymbol": "PLAUR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5329, + "officialSymbol": "PLAUR", + "officialFullName": "plasminogen activator, urokinase receptor", + "uniprotAccessionNumber": "Q03405" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 168, + "assayComponentEndpointName": "BSK_3C_VCAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3C_VCAM1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_3C_VCAM1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene VCAM1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is Immunoglobulin CAM.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 125, + "assayComponentName": "BSK_3C_VCAM1", + "assayComponentDesc": "BSK_3C_VCAM1 is an assay component measured in the BSK_3C assay. It measures VCAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "VCAM-1 antibody is used to tag and quantify the level of vascular cell adhesion molecule 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:VCAM1 | GeneID:7412 | Uniprot_SwissProt_Accession:P19320].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "VCAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 334, + "geneName": "vascular cell adhesion molecule 1", + "description": null, + "geneSymbol": "VCAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7412, + "officialSymbol": "VCAM1", + "officialFullName": "vascular cell adhesion molecule 1", + "uniprotAccessionNumber": "P19320" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 170, + "assayComponentEndpointName": "BSK_3C_Vis", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_3C_Vis was analyzed into 1 assay endpoint. This assay endpoint, BSK_3C_Vis, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of morphology reporter, gain or loss-of-signal activity can be used to understand changes in the background control. \nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is cell conformation.", + "assayFunctionType": "background control", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 126, + "assayComponentName": "BSK_3C_Vis", + "assayComponentDesc": "BSK_3C_Vis is an assay component measured in the BSK_3C assay. It measures NA related to cell morphology using light microscopy technology.", + "assayComponentTargetDesc": "Visual microscropy is used to quantify changes to the morphology of the cells.", + "parameterReadoutType": "single", + "assayDesignType": "morphology reporter", + "assayDesignTypeSub": "cell phenotype", + "biologicalProcessTarget": "cell morphology", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy: Fluorescence microscopy", + "detectionTechnology": "light microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "cellular", + "aid": 7, + "assayName": "BSK_3C", + "assayDesc": "BSK_3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 172, + "assayComponentEndpointName": "BSK_4H_Eotaxin3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_4H_Eotaxin3 was analyzed into 1 assay endpoint. This assay endpoint, BSK_4H_Eotaxin3, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CCL26. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 127, + "assayComponentName": "BSK_4H_Eotaxin3", + "assayComponentDesc": "BSK_4H_Eotaxin3 is an assay component measured in the BSK_4H assay. It measures Eotaxin-3 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Eotaxin-3 antibody is used to tag and quantify the level of chemokine (C-C motif) ligand 26 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from histamine and IL4 [GeneSymbol:CCL26 | GeneID:10344 | Uniprot_SwissProt_Accession:Q9Y258].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Eotaxin-3 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 8, + "assayName": "BSK_4H", + "assayDesc": "BSK_4H is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 365, + "geneName": "chemokine (C-C motif) ligand 26", + "description": null, + "geneSymbol": "CCL26", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10344, + "officialSymbol": "CCL26", + "officialFullName": "chemokine (C-C motif) ligand 26", + "uniprotAccessionNumber": "Q9Y258" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 174, + "assayComponentEndpointName": "BSK_4H_MCP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_4H_MCP1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_4H_MCP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CCL2. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 128, + "assayComponentName": "BSK_4H_MCP1", + "assayComponentDesc": "BSK_4H_MCP1 is an assay component measured in the BSK_4H assay. It measures MCP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MCP-1 antibody is used to tag and quantify the level of chemokine (C-C motif) ligand 2 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from histamine and IL4 [GeneSymbol:CCL2 | GeneID:6347 | Uniprot_SwissProt_Accession:P13500].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MCP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 8, + "assayName": "BSK_4H", + "assayDesc": "BSK_4H is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 291, + "geneName": "chemokine (C-C motif) ligand 2", + "description": null, + "geneSymbol": "CCL2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6347, + "officialSymbol": "CCL2", + "officialFullName": "chemokine (C-C motif) ligand 2", + "uniprotAccessionNumber": "P13500" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 176, + "assayComponentEndpointName": "BSK_4H_Pselectin", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_4H_Pselectin was analyzed into 1 assay endpoint. This assay endpoint, BSK_4H_Pselectin, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene SELP. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is selectins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "selectins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 129, + "assayComponentName": "BSK_4H_Pselectin", + "assayComponentDesc": "BSK_4H_Pselectin is an assay component measured in the BSK_4H assay. It measures P-Selectin antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "P-Selectin antibody is used to tag and quantify the level of selectin P (granule membrane protein 140kDa, antigen CD62) protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from histamine and IL4 [GeneSymbol:SELP | GeneID:6403 | Uniprot_SwissProt_Accession:P16109].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "P-Selectin antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 8, + "assayName": "BSK_4H", + "assayDesc": "BSK_4H is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 294, + "geneName": "selectin P (granule membrane protein 140kDa, antigen CD62)", + "description": null, + "geneSymbol": "SELP", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6403, + "officialSymbol": "SELP", + "officialFullName": "selectin P (granule membrane protein 140kDa, antigen CD62)", + "uniprotAccessionNumber": "P16109" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 180, + "assayComponentEndpointName": "BSK_4H_uPAR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_4HAR was analyzed into 1 assay endpoint. This assay endpoint, BSK_4HAR, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene PLAUR. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is plasmogen activator.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "plasmogen activator", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 131, + "assayComponentName": "BSK_4H_uPAR", + "assayComponentDesc": "BSK_4HAR is an assay component measured in the BSK_4H assay. It measures uPAR antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "uPAR antibody is used to tag and quantify the level of plasminogen activator, urokinase receptor protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from histamine and IL4 [GeneSymbol:PLAUR | GeneID:5329 | Uniprot_SwissProt_Accession:Q03405].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "uPAR antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 8, + "assayName": "BSK_4H", + "assayDesc": "BSK_4H is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 241, + "geneName": "plasminogen activator, urokinase receptor", + "description": null, + "geneSymbol": "PLAUR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5329, + "officialSymbol": "PLAUR", + "officialFullName": "plasminogen activator, urokinase receptor", + "uniprotAccessionNumber": "Q03405" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 182, + "assayComponentEndpointName": "BSK_4H_VCAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_4H_VCAM1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_4H_VCAM1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene VCAM1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is Immunoglobulin CAM.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 132, + "assayComponentName": "BSK_4H_VCAM1", + "assayComponentDesc": "BSK_4H_VCAM1 is an assay component measured in the BSK_4H assay. It measures VCAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "VCAM-1 antibody is used to tag and quantify the level of vascular cell adhesion molecule 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from histamine and IL4 [GeneSymbol:VCAM1 | GeneID:7412 | Uniprot_SwissProt_Accession:P19320].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "VCAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 8, + "assayName": "BSK_4H", + "assayDesc": "BSK_4H is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 334, + "geneName": "vascular cell adhesion molecule 1", + "description": null, + "geneSymbol": "VCAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7412, + "officialSymbol": "VCAM1", + "officialFullName": "vascular cell adhesion molecule 1", + "uniprotAccessionNumber": "P19320" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 184, + "assayComponentEndpointName": "BSK_4H_VEGFRII", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_4H_VEGFRII was analyzed into 1 assay endpoint. This assay endpoint, BSK_4H_VEGFRII, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene KDR. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 133, + "assayComponentName": "BSK_4H_VEGFRII", + "assayComponentDesc": "BSK_4H_VEGFRII is an assay component measured in the BSK_4H assay. It measures VEGFRII antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "VEGFRII antibody is used to tag and quantify the level of kinase insert domain receptor (a type III receptor tyrosine kinase) protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from histamine and IL4 [GeneSymbol:KDR | GeneID:3791 | Uniprot_SwissProt_Accession:P35968].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "VEGFRII antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 8, + "assayName": "BSK_4H", + "assayDesc": "BSK_4H is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium, a human vascular primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 186, + "geneName": "kinase insert domain receptor (a type III receptor tyrosine kinase)", + "description": null, + "geneSymbol": "KDR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3791, + "officialSymbol": "KDR", + "officialFullName": "kinase insert domain receptor (a type III receptor tyrosine kinase)", + "uniprotAccessionNumber": "P35968" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 186, + "assayComponentEndpointName": "BSK_BE3C_HLADR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_HLADR was analyzed into 1 assay endpoint. This assay endpoint, BSK_BE3C_HLADR, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene HLA-DRA. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is MHC Class II.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "MHC Class II", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 134, + "assayComponentName": "BSK_BE3C_HLADR", + "assayComponentDesc": "BSK_BE3C_HLADR is an assay component measured in the BSK_BE3C assay. It measures HLA-DR antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "HLA-DR antibody is used to tag and quantify the level of major histocompatibility complex, class II, DR alpha protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:HLA-DRA | GeneID:3122 | Uniprot_SwissProt_Accession:P01903].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "HLA-DR antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 153, + "geneName": "major histocompatibility complex, class II, DR alpha", + "description": null, + "geneSymbol": "HLA-DRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3122, + "officialSymbol": "HLA-DRA", + "officialFullName": "major histocompatibility complex, class II, DR alpha", + "uniprotAccessionNumber": "P01903" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 732, + "assayComponentEndpointName": "NVS_TR_hDAT", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_TR_hDAT was analyzed into 1 assay endpoint. This assay endpoint, NVS_TR_hDAT, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene SLC6A3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is neurotransmitter transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GBR-12909", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "neurotransmitter transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 469, + "assayComponentName": "NVS_TR_hDAT", + "assayComponentDesc": "NVS_TR_hDAT is one of one assay component(s) measured or calculated from the NVS_TR_hDAT assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-WIN,35,428] are indicative of a change in transporter function and kinetics for the human solute carrier family 6 (neurotransmitter transporter), member 3 [GeneSymbol:SLC6A3 | GeneID:6531 | Uniprot_SwissProt_Accession:Q01959].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-WIN,35,428", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 283, + "assayName": "NVS_TR_hDAT", + "assayDesc": "NVS_TR_hDAT is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 297, + "geneName": "solute carrier family 6 (neurotransmitter transporter), member 3", + "description": null, + "geneSymbol": "SLC6A3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6531, + "officialSymbol": "SLC6A3", + "officialFullName": "solute carrier family 6 (neurotransmitter transporter), member 3", + "uniprotAccessionNumber": "Q01959" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2811854", + "pmid": 2811854, + "title": "Cocaine receptors labeled by [3H]2 beta-carbomethoxy-3 beta-(4-fluorophenyl)tropane", + "author": "Madras BK, Spealman RD, Fahey MA, Neumeyer JL, Saha JK, Milius RA", + "citation": "Madras BK, Spealman RD, Fahey MA, Neumeyer JL, Saha JK, Milius RA. Cocaine receptors labeled by [3H]2 beta-carbomethoxy-3 beta-(4-fluorophenyl)tropane. Mol Pharmacol. 1989 Oct;36(4):518-24. PubMed PMID: 2811854.", + "otherId": "0", + "citationId": 65, + "otherSource": "" + } + }, + { + "aeid": 733, + "assayComponentEndpointName": "NVS_TR_hNET", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_TR_hNET was analyzed into 1 assay endpoint. This assay endpoint, NVS_TR_hNET, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene SLC6A2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is neurotransmitter transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Desipramine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "neurotransmitter transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 470, + "assayComponentName": "NVS_TR_hNET", + "assayComponentDesc": "NVS_TR_hNET is one of one assay component(s) measured or calculated from the NVS_TR_hNET assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Nisoxetine] are indicative of a change in transporter function and kinetics for the human solute carrier family 6 (neurotransmitter transporter), member 2 [GeneSymbol:SLC6A2 | GeneID:6530 | Uniprot_SwissProt_Accession:P23975].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Nisoxetine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 284, + "assayName": "NVS_TR_hNET", + "assayDesc": "NVS_TR_hNET is a biochemical, single-readout assay that uses extracted gene-proteins from CHO in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "CHO", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 296, + "geneName": "solute carrier family 6 (neurotransmitter transporter), member 2", + "description": null, + "geneSymbol": "SLC6A2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6530, + "officialSymbol": "SLC6A2", + "officialFullName": "solute carrier family 6 (neurotransmitter transporter), member 2", + "uniprotAccessionNumber": "P23975" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 734, + "assayComponentEndpointName": "NVS_TR_hSERT", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_TR_hSERT was analyzed into 1 assay endpoint. This assay endpoint, NVS_TR_hSERT, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene SLC6A4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is neurotransmitter transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Imipramine HCl;Clomipramine HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "neurotransmitter transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 471, + "assayComponentName": "NVS_TR_hSERT", + "assayComponentDesc": "NVS_TR_hSERT is one of one assay component(s) measured or calculated from the NVS_TR_hSERT assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-N-methyl-citalopram] are indicative of a change in transporter function and kinetics for the human solute carrier family 6 (neurotransmitter transporter), member 4 [GeneSymbol:SLC6A4 | GeneID:6532 | Uniprot_SwissProt_Accession:P31645].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-N-methyl-citalopram", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 285, + "assayName": "NVS_TR_hSERT", + "assayDesc": "NVS_TR_hSERT is a biochemical, single-readout assay that uses extracted gene-proteins from Human platelet membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Human platelet membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 298, + "geneName": "solute carrier family 6 (neurotransmitter transporter), member 4", + "description": null, + "geneSymbol": "SLC6A4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6532, + "officialSymbol": "SLC6A4", + "officialFullName": "solute carrier family 6 (neurotransmitter transporter), member 4", + "uniprotAccessionNumber": "P31645" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2940099", + "pmid": 2940099, + "title": "The effects of some slow channel blocking drugs on high affinity serotonin uptake by rat brain synaptosomes", + "author": "Brown NL, Sirugue O, Worcel M", + "citation": "Brown NL, Sirugue O, Worcel M. The effects of some slow channel blocking drugs on high affinity serotonin uptake by rat brain synaptosomes. Eur J Pharmacol. 1986 Apr 9;123(1):161-5. PubMed PMID: 2940099.", + "otherId": "0", + "citationId": 79, + "otherSource": "" + } + }, + { + "aeid": 735, + "assayComponentEndpointName": "NVS_TR_rAdoT", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_TR_rAdoT was analyzed into 1 assay endpoint. This assay endpoint, NVS_TR_rAdoT, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Slc29a1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is nucleoside transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Nitrobenzylthioinosine (NBTI)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "nucleoside transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 472, + "assayComponentName": "NVS_TR_rAdoT", + "assayComponentDesc": "NVS_TR_rAdoT is one of one assay component(s) measured or calculated from the NVS_TR_rAdoT assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Nitrobenzylthioinosine] are indicative of a change in transporter function and kinetics for the Norway rat solute carrier family 29 (equilibrative nucleoside transporter), member 1 [GeneSymbol:Slc29a1 | GeneID:63997 | Uniprot_SwissProt_Accession:O54698].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Nitrobenzylthioinosine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 286, + "assayName": "NVS_TR_rAdoT", + "assayDesc": "NVS_TR_rAdoT is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 432, + "geneName": "solute carrier family 29 (equilibrative nucleoside transporter), member 1", + "description": null, + "geneSymbol": "Slc29a1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 63997, + "officialSymbol": "Slc29a1", + "officialFullName": "solute carrier family 29 (equilibrative nucleoside transporter), member 1", + "uniprotAccessionNumber": "O54698" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7086410", + "pmid": 7086410, + "title": "[3H]nitrobenzylthioinosine binding as a probe for the study of adenosine uptake sites in brain", + "author": "Marangos PJ, Patel J, Clark-Rosenberg R, Martino AM", + "citation": "Marangos PJ, Patel J, Clark-Rosenberg R, Martino AM. [3H]nitrobenzylthioinosine binding as a probe for the study of adenosine uptake sites in brain. J Neurochem. 1982 Jul;39(1):184-91. PubMed PMID: 7086410.", + "otherId": "0", + "citationId": 132, + "otherSource": "" + } + }, + { + "aeid": 736, + "assayComponentEndpointName": "NVS_TR_rNET", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_TR_rNET was analyzed into 1 assay endpoint. This assay endpoint, NVS_TR_rNET, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Slc6a2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is neurotransmitter transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Desipramine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "neurotransmitter transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 473, + "assayComponentName": "NVS_TR_rNET", + "assayComponentDesc": "NVS_TR_rNET is one of one assay component(s) measured or calculated from the NVS_TR_rNET assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-Nisoxetine] are indicative of a change in transporter function and kinetics for the Norway rat solute carrier family 6 (neurotransmitter transporter), member 2 [GeneSymbol:Slc6a2 | GeneID:83511 | Uniprot_SwissProt_Accession:NA].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-Nisoxetine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 287, + "assayName": "NVS_TR_rNET", + "assayDesc": "NVS_TR_rNET is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 48-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 48-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 439, + "geneName": "solute carrier family 6 (neurotransmitter transporter), member 2", + "description": null, + "geneSymbol": "Slc6a2", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 83511, + "officialSymbol": "Slc6a2", + "officialFullName": "solute carrier family 6 (neurotransmitter transporter), member 2", + "uniprotAccessionNumber": null + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7067730", + "pmid": 7067730, + "title": "High-affinity [3H]desipramine binding in the peripheral and central nervous system: a specific site associated with the neuronal uptake of noradrenaline", + "author": "Raisman R, Sette M, Pimoule C, Briley M, Langer SZ", + "citation": "Raisman R, Sette M, Pimoule C, Briley M, Langer SZ. High-affinity [3H]desipramine binding in the peripheral and central nervous system: a specific site associated with the neuronal uptake of noradrenaline. Eur J Pharmacol. 1982 Mar 12;78(3):345-51. PubMed PMID: 7067730.", + "otherId": "0", + "citationId": 131, + "otherSource": "" + } + }, + { + "aeid": 737, + "assayComponentEndpointName": "NVS_TR_rSERT", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_TR_rSERT was analyzed into 1 assay endpoint. This assay endpoint, NVS_TR_rSERT, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Slc6a4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is neurotransmitter transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Imipramine HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "neurotransmitter transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 474, + "assayComponentName": "NVS_TR_rSERT", + "assayComponentDesc": "NVS_TR_rSERT is one of one assay component(s) measured or calculated from the NVS_TR_rSERT assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-N-methyl-citalopram] are indicative of a change in transporter function and kinetics for the Norway rat solute carrier family 6 (neurotransmitter transporter), member 4 [GeneSymbol:Slc6a4 | GeneID:25553 | Uniprot_SwissProt_Accession:P31652].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-N-methyl-citalopram", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 288, + "assayName": "NVS_TR_rSERT", + "assayDesc": "NVS_TR_rSERT is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain membranes in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain membranes", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 409, + "geneName": "solute carrier family 6 (neurotransmitter transporter), member 4", + "description": null, + "geneSymbol": "Slc6a4", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25553, + "officialSymbol": "Slc6a4", + "officialFullName": "solute carrier family 6 (neurotransmitter transporter), member 4", + "uniprotAccessionNumber": "P31652" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/2940099", + "pmid": 2940099, + "title": "The effects of some slow channel blocking drugs on high affinity serotonin uptake by rat brain synaptosomes", + "author": "Brown NL, Sirugue O, Worcel M", + "citation": "Brown NL, Sirugue O, Worcel M. The effects of some slow channel blocking drugs on high affinity serotonin uptake by rat brain synaptosomes. Eur J Pharmacol. 1986 Apr 9;123(1):161-5. PubMed PMID: 2940099.", + "otherId": "0", + "citationId": 79, + "otherSource": "" + } + }, + { + "aeid": 738, + "assayComponentEndpointName": "NVS_TR_rVMAT2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_TR_rVMAT2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_TR_rVMAT2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, loss-of-signal activity can be used to understand changes in the binding as they relate to the gene Slc18a2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is vesicular transporter.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Reserpine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "transporter", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "vesicular transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 475, + "assayComponentName": "NVS_TR_rVMAT2", + "assayComponentDesc": "NVS_TR_rVMAT2 is one of one assay component(s) measured or calculated from the NVS_TR_rVMAT2 assay. It is designed to make measurements of radioligand binding, a form of binding reporter, as detected with scintillation counting signals by Filter-based radiodetection technology.", + "assayComponentTargetDesc": "Changes to scintillation counting signals produced from the receptor-ligand binding of the key ligand [[3H]-dihydrotetrabenazine] are indicative of a change in transporter function and kinetics for the Norway rat solute carrier family 18 (vesicular monoamine transporter), member 2 [GeneSymbol:Slc18a2 | GeneID:25549 | Uniprot_SwissProt_Accession:Q01827].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "radioligand binding", + "biologicalProcessTarget": "receptor binding", + "detectionTechnologyType": "Radiometry", + "detectionTechnologyTypeSub": "Scintillation counting", + "detectionTechnology": "Filter-based radiodetection", + "keyAssayReagentType": "ligand", + "keyAssayReagent": "[3H]-dihydrotetrabenazine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "transporter", + "aid": 289, + "assayName": "NVS_TR_rVMAT2", + "assayDesc": "NVS_TR_rVMAT2 is a biochemical, single-readout assay that uses extracted gene-proteins from Rat forebrain in a tissue-based cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "brain", + "cellFormat": "tissue-based cell-free", + "cellFreeComponentSource": "Rat forebrain", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 408, + "geneName": "solute carrier family 18 (vesicular monoamine transporter), member 2", + "description": null, + "geneSymbol": "Slc18a2", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25549, + "officialSymbol": "Slc18a2", + "officialFullName": "solute carrier family 18 (vesicular monoamine transporter), member 2", + "uniprotAccessionNumber": "Q01827" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/3748008", + "pmid": 3748008, + "title": "[3H]Dihydrotetrabenazine binding to bovine striatal synaptic vesicles", + "author": "Near JA", + "citation": "Near JA. [3H]Dihydrotetrabenazine binding to bovine striatal synaptic vesicles. Mol Pharmacol. 1986 Sep;30(3):252-7. PubMed PMID: 3748008.", + "otherId": "0", + "citationId": 103, + "otherSource": "" + } + }, + { + "aeid": 739, + "assayComponentEndpointName": "OT_AR_ARELUC_AG_1440", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_AR_ARELUC_AG_1440 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_AR_ARELUC_AG_1440, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of receptor for gain-of-signal activity can be used to understand the reporter gene at the pathway-level as they relate to the gene AR. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "6-alpha-Fluorotestosterone", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 476, + "assayComponentName": "OT_AR_ARELUC_AG_1440", + "assayComponentDesc": "OT_AR_ARELUC_AG_1440 is one of one assay component(s) measured or calculated from the OT_AR_ARELUC_AG_1440 assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by Luciferase technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [D-luciferin] are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human androgen receptor [GeneSymbol:AR | GeneID:367 | Uniprot_SwissProt_Accession:P10275].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "Luciferase", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "D-luciferin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 290, + "assayName": "OT_AR_ARELUC_AG_1440", + "assayDesc": "OT_AR_ARELUC_AG_1440 is a cell-based, single-readout assay that uses CHO-K1, a chinese hamster ovary cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 10029, + "organism": "chinese hamster", + "tissue": "ovary", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "CHO-K1", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 740, + "assayComponentEndpointName": "OT_AR_ARSRC1_0480", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_AR_ARSRC1_0480 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_AR_ARSRC1_0480, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene AR. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4,5-alpha-Dihydrotestosterone", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 477, + "assayComponentName": "OT_AR_ARSRC1_0480", + "assayComponentDesc": "OT_AR_ARSRC1_0480 is one of one assay component(s) measured or calculated from the OT_AR_ARSRC1_0480 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human androgen receptor and SRC proto-oncogene, non-receptor tyrosine kinase [GeneSymbol:AR & SRC | GeneID:367 & 6714 | Uniprot_SwissProt_Accession:P10275 & P12931].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 291, + "assayName": "OT_AR_ARSRC1_0480", + "assayDesc": "OT_AR_ARSRC1_0480 is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 8 hours after chemical dosing in a 384-well plate.", + "timepointHr": 8.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 741, + "assayComponentEndpointName": "OT_AR_ARSRC1_0960", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_AR_ARSRC1_0960 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_AR_ARSRC1_0960, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene AR. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4,5-alpha-Dihydrotestosterone", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 478, + "assayComponentName": "OT_AR_ARSRC1_0960", + "assayComponentDesc": "OT_AR_ARSRC1_0960 is one of one assay component(s) measured or calculated from the OT_AR_ARSRC1_0960 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human androgen receptor and SRC proto-oncogene, non-receptor tyrosine kinase [GeneSymbol:AR & SRC | GeneID:367 & 6714 | Uniprot_SwissProt_Accession:P10275 & P12931].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 292, + "assayName": "OT_AR_ARSRC1_0960", + "assayDesc": "OT_AR_ARSRC1_0960 is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 16 hours after chemical dosing in a 384-well plate.", + "timepointHr": 16.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 742, + "assayComponentEndpointName": "OT_ER_ERaERa_0480", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_ER_ERaERa_0480 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_ER_ERaERa_0480, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene ESR1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 479, + "assayComponentName": "OT_ER_ERaERa_0480", + "assayComponentDesc": "OT_ER_ERaERa_0480 is one of one assay component(s) measured or calculated from the OT_ER_ERaERa_0480 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 293, + "assayName": "OT_ER_ERaERa_0480", + "assayDesc": "OT_ER_ERaERa_0480 is a cell-based assay that uses HEK293T, a human kidney cell line, with measurements taken at 8 hours after chemical dosing in a 384-well plate.", + "timepointHr": 8.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 743, + "assayComponentEndpointName": "OT_ER_ERaERa_1440", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_ER_ERaERa_1440 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_ER_ERaERa_1440, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene ESR1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 480, + "assayComponentName": "OT_ER_ERaERa_1440", + "assayComponentDesc": "OT_ER_ERaERa_1440 is one of one assay component(s) measured or calculated from the OT_ER_ERaERa_1440 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 294, + "assayName": "OT_ER_ERaERa_1440", + "assayDesc": "OT_ER_ERaERa_1440 is a cell-based assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 188, + "assayComponentEndpointName": "BSK_BE3C_IL1a", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_IL1a was analyzed into 1 assay endpoint. This assay endpoint, BSK_BE3C_IL1a, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene IL1A. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is interleukins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 135, + "assayComponentName": "BSK_BE3C_IL1a", + "assayComponentDesc": "BSK_BE3C_IL1a is an assay component measured in the BSK_BE3C assay. It measures IL-1a antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "IL-1a antibody is used to tag and quantify the level of interleukin 1, alpha protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:IL1A | GeneID:3552 | Uniprot_SwissProt_Accession:P01583].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-1a antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 174, + "geneName": "interleukin 1, alpha", + "description": null, + "geneSymbol": "IL1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3552, + "officialSymbol": "IL1A", + "officialFullName": "interleukin 1, alpha", + "uniprotAccessionNumber": "P01583" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 190, + "assayComponentEndpointName": "BSK_BE3C_IP10", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_IP10 was analyzed into 1 assay endpoint. This assay endpoint, BSK_BE3C_IP10, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL10. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 136, + "assayComponentName": "BSK_BE3C_IP10", + "assayComponentDesc": "BSK_BE3C_IP10 is an assay component measured in the BSK_BE3C assay. It measures IP-10 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "IP-10 antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 10 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:CXCL10 | GeneID:3627 | Uniprot_SwissProt_Accession:P02778].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IP-10 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 178, + "geneName": "chemokine (C-X-C motif) ligand 10", + "description": null, + "geneSymbol": "CXCL10", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3627, + "officialSymbol": "CXCL10", + "officialFullName": "chemokine (C-X-C motif) ligand 10", + "uniprotAccessionNumber": "P02778" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 192, + "assayComponentEndpointName": "BSK_BE3C_MIG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_MIG was analyzed into 1 assay endpoint. This assay endpoint, BSK_BE3C_MIG, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL9. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 137, + "assayComponentName": "BSK_BE3C_MIG", + "assayComponentDesc": "BSK_BE3C_MIG is an assay component measured in the BSK_BE3C assay. It measures MIG antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MIG antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 9 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:CXCL9 | GeneID:4283 | Uniprot_SwissProt_Accession:Q07325].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MIG antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 201, + "geneName": "chemokine (C-X-C motif) ligand 9", + "description": null, + "geneSymbol": "CXCL9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4283, + "officialSymbol": "CXCL9", + "officialFullName": "chemokine (C-X-C motif) ligand 9", + "uniprotAccessionNumber": "Q07325" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 194, + "assayComponentEndpointName": "BSK_BE3C_MMP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_MMP1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_BE3C_MMP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene MMP1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metalloproteinase.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 138, + "assayComponentName": "BSK_BE3C_MMP1", + "assayComponentDesc": "BSK_BE3C_MMP1 is an assay component measured in the BSK_BE3C assay. It measures MMP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MMP-1 antibody is used to tag and quantify the level of matrix metallopeptidase 1 (interstitial collagenase) protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:MMP1 | GeneID:4312 | Uniprot_SwissProt_Accession:P03956].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MMP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 203, + "geneName": "matrix metallopeptidase 1 (interstitial collagenase)", + "description": null, + "geneSymbol": "MMP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4312, + "officialSymbol": "MMP1", + "officialFullName": "matrix metallopeptidase 1 (interstitial collagenase)", + "uniprotAccessionNumber": "P03956" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 196, + "assayComponentEndpointName": "BSK_BE3C_PAI1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_PAI1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_BE3C_PAI1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene SERPINE1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is plasmogen activator inhibitor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "plasmogen activator inhibitor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 139, + "assayComponentName": "BSK_BE3C_PAI1", + "assayComponentDesc": "BSK_BE3C_PAI1 is an assay component measured in the BSK_BE3C assay. It measures PAI-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "PAI-1 antibody is used to tag and quantify the level of serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:SERPINE1 | GeneID:5054 | Uniprot_SwissProt_Accession:P05121].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "PAI-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 229, + "geneName": "serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1", + "description": null, + "geneSymbol": "SERPINE1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5054, + "officialSymbol": "SERPINE1", + "officialFullName": "serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1", + "uniprotAccessionNumber": "P05121" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 200, + "assayComponentEndpointName": "BSK_BE3C_TGFb1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_TGFb1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_BE3C_TGFb1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene TGFB1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the growth factor intended target family, where the subfamily is transforming growth factor beta.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "growth factor", + "intendedTargetFamilySub": "transforming growth factor beta", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 141, + "assayComponentName": "BSK_BE3C_TGFb1", + "assayComponentDesc": "BSK_BE3C_TGFb1 is an assay component measured in the BSK_BE3C assay. It measures TGF-b1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "TGF-b1 antibody is used to tag and quantify the level of transforming growth factor, beta 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:TGFB1 | GeneID:7040 | Uniprot_SwissProt_Accession:P01137].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TGF-b1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 319, + "geneName": "transforming growth factor, beta 1", + "description": null, + "geneSymbol": "TGFB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7040, + "officialSymbol": "TGFB1", + "officialFullName": "transforming growth factor, beta 1", + "uniprotAccessionNumber": "P01137" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 202, + "assayComponentEndpointName": "BSK_BE3C_tPA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3C_tPA was analyzed into 1 assay endpoint. This assay endpoint, BSK_BE3C_tPA, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene PLAT. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is serine protease.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "serine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 142, + "assayComponentName": "BSK_BE3C_tPA", + "assayComponentDesc": "BSK_BE3C_tPA is an assay component measured in the BSK_BE3C assay. It measures tPA antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "tPA antibody is used to tag and quantify the level of plasminogen activator, tissue protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:PLAT | GeneID:5327 | Uniprot_SwissProt_Accession:P00750].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "tPA antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 239, + "geneName": "plasminogen activator, tissue", + "description": null, + "geneSymbol": "PLAT", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5327, + "officialSymbol": "PLAT", + "officialFullName": "plasminogen activator, tissue", + "uniprotAccessionNumber": "P00750" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 744, + "assayComponentEndpointName": "OT_ER_ERaERb_0480", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_ER_ERaERb_0480 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_ER_ERaERb_0480, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene ESR1 and ESR2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 481, + "assayComponentName": "OT_ER_ERaERb_0480", + "assayComponentDesc": "OT_ER_ERaERb_0480 is one of one assay component(s) measured or calculated from the OT_ER_ERaERb_0480 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human estrogen receptor 1 and estrogen receptor 2 (ER beta) [GeneSymbol:ESR1 & ESR2 | GeneID:2099 & 2100 | Uniprot_SwissProt_Accession:P03372 & Q92731].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 295, + "assayName": "OT_ER_ERaERb_0480", + "assayDesc": "OT_ER_ERaERb_0480 is a cell-based assay that uses HEK293T, a human kidney cell line, with measurements taken at 8 hours after chemical dosing in a 384-well plate.", + "timepointHr": 8.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 745, + "assayComponentEndpointName": "OT_ER_ERaERb_1440", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_ER_ERaERb_1440 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_ER_ERaERb_1440, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene ESR1 and ESR2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 482, + "assayComponentName": "OT_ER_ERaERb_1440", + "assayComponentDesc": "OT_ER_ERaERb_1440 is one of one assay component(s) measured or calculated from the OT_ER_ERaERb_1440 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human estrogen receptor 1 and estrogen receptor 2 (ER beta) [GeneSymbol:ESR1 & ESR2 | GeneID:2099 & 2100 | Uniprot_SwissProt_Accession:P03372 & Q92731].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 296, + "assayName": "OT_ER_ERaERb_1440", + "assayDesc": "OT_ER_ERaERb_1440 is a cell-based assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 746, + "assayComponentEndpointName": "OT_ER_ERbERb_0480", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_ER_ERbERb_0480 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_ER_ERbERb_0480, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene ESR2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 483, + "assayComponentName": "OT_ER_ERbERb_0480", + "assayComponentDesc": "OT_ER_ERbERb_0480 is one of one assay component(s) measured or calculated from the OT_ER_ERbERb_0480 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human estrogen receptor 2 (ER beta) [GeneSymbol:ESR2 | GeneID:2100 | Uniprot_SwissProt_Accession:Q92731].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 297, + "assayName": "OT_ER_ERbERb_0480", + "assayDesc": "OT_ER_ERbERb_0480 is a cell-based assay that uses HEK293T, a human kidney cell line, with measurements taken at 8 hours after chemical dosing in a 384-well plate.", + "timepointHr": 8.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 118, + "geneName": "estrogen receptor 2 (ER beta)", + "description": null, + "geneSymbol": "ESR2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2100, + "officialSymbol": "ESR2", + "officialFullName": "estrogen receptor 2 (ER beta)", + "uniprotAccessionNumber": "Q92731" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 747, + "assayComponentEndpointName": "OT_ER_ERbERb_1440", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_ER_ERbERb_1440 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_ER_ERbERb_1440, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene ESR2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 484, + "assayComponentName": "OT_ER_ERbERb_1440", + "assayComponentDesc": "OT_ER_ERbERb_1440 is one of one assay component(s) measured or calculated from the OT_ER_ERbERb_1440 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human estrogen receptor 2 (ER beta) [GeneSymbol:ESR2 | GeneID:2100 | Uniprot_SwissProt_Accession:Q92731].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 298, + "assayName": "OT_ER_ERbERb_1440", + "assayDesc": "OT_ER_ERbERb_1440 is a cell-based assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 118, + "geneName": "estrogen receptor 2 (ER beta)", + "description": null, + "geneSymbol": "ESR2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2100, + "officialSymbol": "ESR2", + "officialFullName": "estrogen receptor 2 (ER beta)", + "uniprotAccessionNumber": "Q92731" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 750, + "assayComponentEndpointName": "OT_ERa_GFPERaERE_0120", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_ERa_GFPERaERE_0120 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_ERa_EREGFP_0120, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of receptor for gain-of-signal activity can be used to understand the reporter gene at the pathway-level as they relate to the gene ESR1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "(Z)-4-Hydroxytamoxifen", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 487, + "assayComponentName": "OT_ERa_GFPERaERE_0120", + "assayComponentDesc": "OT_ERa_GFPERaERE_0120 is one of one assay component(s) measured or calculated from the OT_ERa_GFPERaERE_0120 assay. It is designed to make measurements of fluorescent protein induction, a form of inducible reporter, as detected with optical microscopy: fluorescence microscopy signals by Microscopy technology.", + "assayComponentTargetDesc": "Changes to optical microscopy: fluorescence microscopy signals produced from the fluorescent protein induction are indicative of a change in the receptor function and kinetics for the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "fluorescent protein induction", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy: Fluorescence microscopy", + "detectionTechnology": "Microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 301, + "assayName": "OT_ERa_GFPERaERE_0120", + "assayDesc": "OT_ERa_GFPERaERE_0120 is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 2 hours after chemical dosing in a 384-well plate.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1038/onc.2013.550", + "url": "https://pubmed.ncbi.nlm.nih.gov/24441042/", + "pmid": 24441042, + "title": "ystems level-based RNAi screening by high content analysis identifies UBR5 as a regulator of estrogen receptor-? protein levels and activity", + "author": "Bolt MJ, Stossi F, Callison AM, Mancini MG, Dandekar R, Mancini MA", + "citation": "Bolt MJ, Stossi F, Callison AM, Mancini MG, Dandekar R, Mancini MA. Systems level-based RNAi screening by high content analysis identifies UBR5 as a regulator of estrogen receptor-? protein levels and activity. Oncogene. 2015 Jan 8;34(2):154-64. doi: 10.1038/onc.2013.550. Epub 2014 Jan 20. PMID: 24441042; PMCID: PMC4871123.", + "otherId": "0", + "citationId": 252, + "otherSource": "" + } + }, + { + "aeid": 751, + "assayComponentEndpointName": "OT_ERa_GFPERaERE_0480", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_ERa_GFPERaERE_0480 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_ERa_EREGFP_0480, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, measures of receptor for gain-of-signal activity can be used to understand the reporter gene at the pathway-level as they relate to the gene ESR1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "(Z)-4-Hydroxytamoxifen", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 488, + "assayComponentName": "OT_ERa_GFPERaERE_0480", + "assayComponentDesc": "OT_ERa_GFPERaERE_0480 is one of one assay component(s) measured or calculated from the OT_ERa_GFPERaERE_0480 assay. It is designed to make measurements of fluorescent protein induction, a form of inducible reporter, as detected with optical microscopy: fluorescence microscopy signals by Microscopy technology.", + "assayComponentTargetDesc": "Changes to optical microscopy: fluorescence microscopy signals produced from the fluorescent protein induction are indicative of a change in the receptor function and kinetics for the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "fluorescent protein induction", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Microscopy", + "detectionTechnologyTypeSub": "Optical microscopy: Fluorescence microscopy", + "detectionTechnology": "Microscopy", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 302, + "assayName": "OT_ERa_GFPERaERE_0480", + "assayDesc": "OT_ERa_GFPERaERE_0480 is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 8 hours after chemical dosing in a 384-well plate.", + "timepointHr": 8.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1038/onc.2013.550", + "url": "https://pubmed.ncbi.nlm.nih.gov/24441042/", + "pmid": 24441042, + "title": "ystems level-based RNAi screening by high content analysis identifies UBR5 as a regulator of estrogen receptor-? protein levels and activity", + "author": "Bolt MJ, Stossi F, Callison AM, Mancini MG, Dandekar R, Mancini MA", + "citation": "Bolt MJ, Stossi F, Callison AM, Mancini MG, Dandekar R, Mancini MA. Systems level-based RNAi screening by high content analysis identifies UBR5 as a regulator of estrogen receptor-? protein levels and activity. Oncogene. 2015 Jan 8;34(2):154-64. doi: 10.1038/onc.2013.550. Epub 2014 Jan 20. PMID: 24441042; PMCID: PMC4871123.", + "otherId": "0", + "citationId": 252, + "otherSource": "" + } + }, + { + "aeid": 753, + "assayComponentEndpointName": "OT_FXR_FXRSRC1_0480", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_FXR_FXRSRC1_0480 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_FXR_FXRSRC1_0480, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene NR1H4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GW4064", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 490, + "assayComponentName": "OT_FXR_FXRSRC1_0480", + "assayComponentDesc": "OT_FXR_FXRSRC1_0480 is one of one assay component(s) measured or calculated from the OT_FXR_FXRSRC1_0480 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human SRC proto-oncogene, non-receptor tyrosine kinase and nuclear receptor subfamily 1, group H, member 4 [GeneSymbol:SRC & NR1H4 | GeneID:6714 & 9971 | Uniprot_SwissProt_Accession:P12931 & Q96RI1].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 304, + "assayName": "OT_FXR_FXRSRC1_0480", + "assayDesc": "OT_FXR_FXRSRC1_0480 is a cell-based assay that uses HEK293T, a human kidney cell line, with measurements taken at 8 hours after chemical dosing in a 384-well plate.", + "timepointHr": 8.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 303, + "geneName": "SRC proto-oncogene, non-receptor tyrosine kinase", + "description": null, + "geneSymbol": "SRC", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6714, + "officialSymbol": "SRC", + "officialFullName": "SRC proto-oncogene, non-receptor tyrosine kinase", + "uniprotAccessionNumber": "P12931" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 754, + "assayComponentEndpointName": "OT_FXR_FXRSRC1_1440", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_FXR_FXRSRC1_1440 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_FXR_FXRSRC1_1440, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene NR1H4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GW4064", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 491, + "assayComponentName": "OT_FXR_FXRSRC1_1440", + "assayComponentDesc": "OT_FXR_FXRSRC1_1440 is one of one assay component(s) measured or calculated from the OT_FXR_FXRSRC1_1440 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human SRC proto-oncogene, non-receptor tyrosine kinase and nuclear receptor subfamily 1, group H, member 4 [GeneSymbol:SRC & NR1H4 | GeneID:6714 & 9971 | Uniprot_SwissProt_Accession:P12931 & Q96RI1].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 305, + "assayName": "OT_FXR_FXRSRC1_1440", + "assayDesc": "OT_FXR_FXRSRC1_1440 is a cell-based assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 303, + "geneName": "SRC proto-oncogene, non-receptor tyrosine kinase", + "description": null, + "geneSymbol": "SRC", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6714, + "officialSymbol": "SRC", + "officialFullName": "SRC proto-oncogene, non-receptor tyrosine kinase", + "uniprotAccessionNumber": "P12931" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 755, + "assayComponentEndpointName": "OT_NURR1_NURR1RXRa_0480", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_NURR1_NURR1RXRa_0480 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_NURR1_NURR1RXRa_0480, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene RXRA. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Isoproterenol;Fenoterol", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 492, + "assayComponentName": "OT_NURR1_NURR1RXRa_0480", + "assayComponentDesc": "OT_NURR1_NURR1RXRa_0480 is one of one assay component(s) measured or calculated from the OT_NURR1_NURR1RXRa_0480 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human nuclear receptor subfamily 4, group A, member 2 and retinoid X receptor, alpha [GeneSymbol:NR4A2 & RXRA | GeneID:4929 & 6256 | Uniprot_SwissProt_Accession:P43354 & P19793].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 306, + "assayName": "OT_NURR1_NURR1RXRa_0480", + "assayDesc": "OT_NURR1_NURR1RXRa_0480 is a cell-based assay that uses HEK293T, a human kidney cell line, with measurements taken at 8 hours after chemical dosing in a 384-well plate.", + "timepointHr": 8.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 224, + "geneName": "nuclear receptor subfamily 4, group A, member 2", + "description": null, + "geneSymbol": "NR4A2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4929, + "officialSymbol": "NR4A2", + "officialFullName": "nuclear receptor subfamily 4, group A, member 2", + "uniprotAccessionNumber": "P43354" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 756, + "assayComponentEndpointName": "OT_NURR1_NURR1RXRa_1440", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_NURR1_NURR1RXRa_1440 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_NURR1_NURR1RXRa_1440, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene RXRA. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Isoproterenol;Fenoterol", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 493, + "assayComponentName": "OT_NURR1_NURR1RXRa_1440", + "assayComponentDesc": "OT_NURR1_NURR1RXRa_1440 is one of one assay component(s) measured or calculated from the OT_NURR1_NURR1RXRa_1440 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human nuclear receptor subfamily 4, group A, member 2 and retinoid X receptor, alpha [GeneSymbol:NR4A2 & RXRA | GeneID:4929 & 6256 | Uniprot_SwissProt_Accession:P43354 & P19793].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 307, + "assayName": "OT_NURR1_NURR1RXRa_1440", + "assayDesc": "OT_NURR1_NURR1RXRa_1440 is a cell-based assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 224, + "geneName": "nuclear receptor subfamily 4, group A, member 2", + "description": null, + "geneSymbol": "NR4A2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4929, + "officialSymbol": "NR4A2", + "officialFullName": "nuclear receptor subfamily 4, group A, member 2", + "uniprotAccessionNumber": "P43354" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 757, + "assayComponentEndpointName": "OT_PPARg_PPARgSRC1_0480", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_PPARg_PPARgSRC1_0480 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_PPARg_PPARgSRC1_0480, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene PPARG. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GW1929", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 494, + "assayComponentName": "OT_PPARg_PPARgSRC1_0480", + "assayComponentDesc": "OT_PPARg_PPARgSRC1_0480 is one of one assay component(s) measured or calculated from the OT_PPARg_PPARgSRC1_0480 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human peroxisome proliferator-activated receptor gamma and SRC proto-oncogene, non-receptor tyrosine kinase [GeneSymbol:PPARG & SRC | GeneID:5468 & 6714 | Uniprot_SwissProt_Accession:P37231 & P12931].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 308, + "assayName": "OT_PPARg_PPARgSRC1_0480", + "assayDesc": "OT_PPARg_PPARgSRC1_0480 is a cell-based assay that uses HEK293T, a human kidney cell line, with measurements taken at 8 hours after chemical dosing in a 384-well plate.", + "timepointHr": 8.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 250, + "geneName": "peroxisome proliferator-activated receptor gamma", + "description": null, + "geneSymbol": "PPARG", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5468, + "officialSymbol": "PPARG", + "officialFullName": "peroxisome proliferator-activated receptor gamma", + "uniprotAccessionNumber": "P37231" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 758, + "assayComponentEndpointName": "OT_PPARg_PPARgSRC1_1440", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component OT_PPARg_PPARgSRC1_1440 was analyzed into 1 assay endpoint. \r\nThis assay endpoint, OT_PPARg_PPARgSRC1_1440, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of binding reporter, measures of receptor for gain-of-signal activity can be used to understand the binding at the pathway-level as they relate to the gene PPARG. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "binding", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "GW1929", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 495, + "assayComponentName": "OT_PPARg_PPARgSRC1_1440", + "assayComponentDesc": "OT_PPARg_PPARgSRC1_1440 is one of one assay component(s) measured or calculated from the OT_PPARg_PPARgSRC1_1440 assay. It is designed to make measurements of protein fragment complementation, a form of binding reporter, as detected with fluorescence intensity signals by Protein-fragment Complementation technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from the protein fragment complementation are indicative of a change in the receptor function and kinetics for the human peroxisome proliferator-activated receptor gamma and SRC proto-oncogene, non-receptor tyrosine kinase [GeneSymbol:PPARG & SRC | GeneID:5468 & 6714 | Uniprot_SwissProt_Accession:P37231 & P12931].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "protein fragment complementation assay", + "biologicalProcessTarget": "protein stabilization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Protein-fragment Complementation", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 309, + "assayName": "OT_PPARg_PPARgSRC1_1440", + "assayDesc": "OT_PPARg_PPARgSRC1_1440 is a cell-based assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 384-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "protein complex format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 6, + "assaySourceName": "OT", + "assaySourceLongName": "Odyssey Thera", + "assaySourceDesc": "Odyssey Thera is a drug discovery company focusing on high-throughput screening with a particular focus on developing novel protein:protein interaction assays using protein-fragment complementation technology. ", + "gene": { + "geneId": 250, + "geneName": "peroxisome proliferator-activated receptor gamma", + "description": null, + "geneSymbol": "PPARG", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5468, + "officialSymbol": "PPARG", + "officialFullName": "peroxisome proliferator-activated receptor gamma", + "uniprotAccessionNumber": "P37231" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/16680159", + "pmid": 16680159, + "title": "Identifying off-target effects and hidden phenotypes of drugs in human cells", + "author": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK", + "citation": "MacDonald ML, Lamerdin J, Owens S, Keon BH, Bilter GK, Shang Z, Huang Z, Yu H, Dias J, Minami T, Michnick SW, Westwick JK. Identifying off-target effects and hidden phenotypes of drugs in human cells. Nat Chem Biol. 2006 Jun;2(6):329-37. Epub 2006 May 7. PubMed PMID: 16680159.", + "otherId": "0", + "citationId": 230, + "otherSource": "" + } + }, + { + "aeid": 759, + "assayComponentEndpointName": "TOX21_AR_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AR_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AR_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "R1881", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 496, + "assayComponentName": "TOX21_AR_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_AR_BLA_Agonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_AR_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to AR gene(s) using a positive control of R1881", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 310, + "assayName": "TOX21_AR_BLA_Agonist", + "assayDesc": "TOX21_AR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 760, + "assayComponentEndpointName": "TOX21_AR_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AR_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AR_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "R1881", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 497, + "assayComponentName": "TOX21_AR_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_AR_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_AR_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to AR gene(s) using a positive control of R1881", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 310, + "assayName": "TOX21_AR_BLA_Agonist", + "assayDesc": "TOX21_AR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 761, + "assayComponentEndpointName": "TOX21_AR_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AR_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AR_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "R1881", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 498, + "assayComponentName": "TOX21_AR_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_AR_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_AR_BLA_Agonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to AR gene(s) using a positive control of R1881 ", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 310, + "assayName": "TOX21_AR_BLA_Agonist", + "assayDesc": "TOX21_AR_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 762, + "assayComponentEndpointName": "TOX21_AR_BLA_Antagonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AR_BLA_Antagonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AR_BLA_Antagonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Cyproterone acetate", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 499, + "assayComponentName": "TOX21_AR_BLA_Antagonist_ratio", + "assayComponentDesc": "TOX21_AR_BLA_Antagonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_AR_BLA_Antagonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to AR gene(s) using a positive control of Cyproterone acetate ", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 311, + "assayName": "TOX21_AR_BLA_Antagonist", + "assayDesc": "TOX21_AR_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 212, + "assayComponentEndpointName": "BSK_CASM3C_IL8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_IL8 was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3C_IL8, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL8. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is interleukins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 147, + "assayComponentName": "BSK_CASM3C_IL8", + "assayComponentDesc": "BSK_CASM3C_IL8 is an assay component measured in the BSK_CASM3C assay. It measures IL-8 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "IL-8 antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 8 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:CXCL8 | GeneID:3576 | Uniprot_SwissProt_Accession:P10145].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-8 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 177, + "geneName": "chemokine (C-X-C motif) ligand 8", + "description": null, + "geneSymbol": "CXCL8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3576, + "officialSymbol": "CXCL8", + "officialFullName": "chemokine (C-X-C motif) ligand 8", + "uniprotAccessionNumber": "P10145" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 214, + "assayComponentEndpointName": "BSK_CASM3C_LDLR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_LDLR was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3C_LDLR, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene LDLR. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the misc protein intended target family, where the subfamily is LDL receptor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "misc protein", + "intendedTargetFamilySub": "LDL receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 148, + "assayComponentName": "BSK_CASM3C_LDLR", + "assayComponentDesc": "BSK_CASM3C_LDLR is an assay component measured in the BSK_CASM3C assay. It measures LDLR antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "LDLR antibody is used to tag and quantify the level of low density lipoprotein receptor protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:LDLR | GeneID:3949 | Uniprot_SwissProt_Accession:P01130].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "LDLR antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 190, + "geneName": "low density lipoprotein receptor", + "description": null, + "geneSymbol": "LDLR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3949, + "officialSymbol": "LDLR", + "officialFullName": "low density lipoprotein receptor", + "uniprotAccessionNumber": "P01130" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 216, + "assayComponentEndpointName": "BSK_CASM3C_MCP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_MCP1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3C_MCP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CCL2. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 149, + "assayComponentName": "BSK_CASM3C_MCP1", + "assayComponentDesc": "BSK_CASM3C_MCP1 is an assay component measured in the BSK_CASM3C assay. It measures MCP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MCP-1 antibody is used to tag and quantify the level of chemokine (C-C motif) ligand 2 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:CCL2 | GeneID:6347 | Uniprot_SwissProt_Accession:P13500].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MCP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 291, + "geneName": "chemokine (C-C motif) ligand 2", + "description": null, + "geneSymbol": "CCL2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6347, + "officialSymbol": "CCL2", + "officialFullName": "chemokine (C-C motif) ligand 2", + "uniprotAccessionNumber": "P13500" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 218, + "assayComponentEndpointName": "BSK_CASM3C_MCSF", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_MCSF was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3C_MCSF, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CSF1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is colony stimulating factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "colony stimulating factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 150, + "assayComponentName": "BSK_CASM3C_MCSF", + "assayComponentDesc": "BSK_CASM3C_MCSF is an assay component measured in the BSK_CASM3C assay. It measures M-CSF antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "M-CSF antibody is used to tag and quantify the level of colony stimulating factor 1 (macrophage) protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:CSF1 | GeneID:1435 | Uniprot_SwissProt_Accession:P09603].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "M-CSF antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 72, + "geneName": "colony stimulating factor 1 (macrophage)", + "description": null, + "geneSymbol": "CSF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1435, + "officialSymbol": "CSF1", + "officialFullName": "colony stimulating factor 1 (macrophage)", + "uniprotAccessionNumber": "P09603" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 220, + "assayComponentEndpointName": "BSK_CASM3C_MIG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_MIG was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3C_MIG, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL9. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 151, + "assayComponentName": "BSK_CASM3C_MIG", + "assayComponentDesc": "BSK_CASM3C_MIG is an assay component measured in the BSK_CASM3C assay. It measures MIG antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MIG antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 9 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:CXCL9 | GeneID:4283 | Uniprot_SwissProt_Accession:Q07325].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MIG antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 201, + "geneName": "chemokine (C-X-C motif) ligand 9", + "description": null, + "geneSymbol": "CXCL9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4283, + "officialSymbol": "CXCL9", + "officialFullName": "chemokine (C-X-C motif) ligand 9", + "uniprotAccessionNumber": "Q07325" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 222, + "assayComponentEndpointName": "BSK_CASM3C_Proliferation", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_Proliferation was analyzed into 1 assay endpoint. \nThis assay endpoint, BSK_CASM3C_Proliferation, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of total protein for gain or loss-of-signal activity can be used to understand the viability at the cellular-level. \nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is proliferation.", + "assayFunctionType": "viability", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 152, + "assayComponentName": "BSK_CASM3C_Proliferation", + "assayComponentDesc": "BSK_CASM3C_Proliferation is an assay component measured in the BSK_CASM3C assay. It measures 0.1% sulforhodamine related to cell proliferation using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "Proliferation in the CASM3C system is a measure of coronary artery smooth muscle cell proliferation which is important to the process of vasacular biology and restenosis.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 224, + "assayComponentEndpointName": "BSK_CASM3C_SAA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_SAA was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3C_SAA, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene SAA1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is apolipoproteins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "apolipoproteins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 153, + "assayComponentName": "BSK_CASM3C_SAA", + "assayComponentDesc": "BSK_CASM3C_SAA is an assay component measured in the BSK_CASM3C assay. It measures SAA antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Serum Amyloid A (SAA) is a member of the apolipoprotein family that is an acute phase reactant. SAA is categorized as an inflammation-related activity in the CASM3C system modeling Th1 vascular smooth muscle inflammation. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:SAA1 | GeneID:6288 | Uniprot_SwissProt_Accession:P0DJI8].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "SAA antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 290, + "geneName": "serum amyloid A1", + "description": null, + "geneSymbol": "SAA1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6288, + "officialSymbol": "SAA1", + "officialFullName": "serum amyloid A1", + "uniprotAccessionNumber": "P0DJI8" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 226, + "assayComponentEndpointName": "BSK_CASM3C_SRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_SRB was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3C_SRB, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is cell conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 154, + "assayComponentName": "BSK_CASM3C_SRB", + "assayComponentDesc": "BSK_CASM3C_SRB is an assay component measured in the BSK_CASM3C assay. It measures 0.1% sulforhodamine related to cell death using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "SRB in the CASM3C system is a measure of the total protein content of coronary artery smooth muscle cells. Cell viability of adherent cells is measured by Sulforhodamine B (SRB) staining, a method that determines cell density by measuring total protein content of test wells.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 763, + "assayComponentEndpointName": "TOX21_AR_BLA_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_AR_BLA_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 500, + "assayComponentName": "TOX21_AR_BLA_Antagonist_viability", + "assayComponentDesc": "TOX21_AR_BLA_Antagonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 311, + "assayName": "TOX21_AR_BLA_Antagonist", + "assayDesc": "TOX21_AR_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 764, + "assayComponentEndpointName": "TOX21_AR_LUC_MDAKB2_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AR_LUC_MDAKB2_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AR_LUC_MDAKB2_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "R1881", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 501, + "assayComponentName": "TOX21_AR_LUC_MDAKB2_Agonist", + "assayComponentDesc": "TOX21_AR_LUC_MDAKB2_Agonist is one of one assay component(s) measured or calculated from the TOX21_AR_LUC_MDAkb2_Agonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human androgen receptor [GeneSymbol:AR | GeneID:367 | Uniprot_SwissProt_Accession:P10275].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 312, + "assayName": "TOX21_AR_LUC_MDAKB2_Agonist", + "assayDesc": "TOX21_AR_LUC_MDAKB2_Agonist is a cell-based, single-readout assay that uses MDA-kb2, a human breast cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MDA-kb2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.6b00347", + "url": "https://pubmed.ncbi.nlm.nih.gov/27933809/", + "pmid": 27933809, + "title": "Development and Validation of a Computational Model for Androgen Receptor Activity", + "author": "Kleinstreuer NC, Ceger P, Watt ED, Martin M, Houck K, Browne P, Thomas RS, Casey WM, Dix DJ, Allen D, Sakamuru S, Xia M, Huang R, Judson R", + "citation": "Kleinstreuer NC, Ceger P, Watt ED, Martin M, Houck K, Browne P, Thomas RS, Casey WM, Dix DJ, Allen D, Sakamuru S, Xia M, Huang R, Judson R. Development and Validation of a Computational Model for Androgen Receptor Activity. Chem Res Toxicol. 2017 Apr 17;30(4):946-964. doi: 10.1021/acs.chemrestox.6b00347. Epub 2016 Dec 9. PMID: 27933809; PMCID: PMC5396026.", + "otherId": "0", + "citationId": 266, + "otherSource": "" + } + }, + { + "aeid": 765, + "assayComponentEndpointName": "TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene AR. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Nilutamide", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 502, + "assayComponentName": "TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881", + "assayComponentDesc": "TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881 is one of one assay component(s) measured or calculated from the TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881 assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Androgen receptor (AR) is an important member of the nuclear receptor family. Its signaling plays a critical role in AR-dependent prostate cancer and other androgen related diseases. Considerable attention has been given in the past decades to develop methods to study and screen for the environmental chemicals that have the potential to interfere with metabolic homeostasis, reproduction, developmental and behavioral functions. Therefore AR binding assay for screening androgen antagonists can be used to identify potential endocrine disruptors. Changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] are indicative of changes in transcriptional gene expression due to antagonist activity regulated by the human androgen receptor [GeneSymbol:AR | GeneID:367 | Uniprot_SwissProt_Accession:P10275].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 313, + "assayName": "TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881", + "assayDesc": "TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881 is a cell-based, single-readout assay that uses MDA-kb2, a human breast cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. This is an secondary assay to TOX21_AR_LUC_MDAKB2_Agonist for antagonist specificity. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MDA-kb2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP AR", + "description": "Androgen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.6b00347", + "url": "https://pubmed.ncbi.nlm.nih.gov/27933809/", + "pmid": 27933809, + "title": "Development and Validation of a Computational Model for Androgen Receptor Activity", + "author": "Kleinstreuer NC, Ceger P, Watt ED, Martin M, Houck K, Browne P, Thomas RS, Casey WM, Dix DJ, Allen D, Sakamuru S, Xia M, Huang R, Judson R", + "citation": "Kleinstreuer NC, Ceger P, Watt ED, Martin M, Houck K, Browne P, Thomas RS, Casey WM, Dix DJ, Allen D, Sakamuru S, Xia M, Huang R, Judson R. Development and Validation of a Computational Model for Androgen Receptor Activity. Chem Res Toxicol. 2017 Apr 17;30(4):946-964. doi: 10.1021/acs.chemrestox.6b00347. Epub 2016 Dec 9. PMID: 27933809; PMCID: PMC5396026.", + "otherId": "0", + "citationId": 266, + "otherSource": "" + } + }, + { + "aeid": 766, + "assayComponentEndpointName": "TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 503, + "assayComponentName": "TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881_viability", + "assayComponentDesc": "TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 313, + "assayName": "TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881", + "assayDesc": "TOX21_AR_LUC_MDAKB2_Antagonist_10nM_R1881 is a cell-based, single-readout assay that uses MDA-kb2, a human breast cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate. This is an secondary assay to TOX21_AR_LUC_MDAKB2_Agonist for antagonist specificity. ", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MDA-kb2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1021/acs.chemrestox.6b00347", + "url": "https://pubmed.ncbi.nlm.nih.gov/27933809/", + "pmid": 27933809, + "title": "Development and Validation of a Computational Model for Androgen Receptor Activity", + "author": "Kleinstreuer NC, Ceger P, Watt ED, Martin M, Houck K, Browne P, Thomas RS, Casey WM, Dix DJ, Allen D, Sakamuru S, Xia M, Huang R, Judson R", + "citation": "Kleinstreuer NC, Ceger P, Watt ED, Martin M, Houck K, Browne P, Thomas RS, Casey WM, Dix DJ, Allen D, Sakamuru S, Xia M, Huang R, Judson R. Development and Validation of a Computational Model for Androgen Receptor Activity. Chem Res Toxicol. 2017 Apr 17;30(4):946-964. doi: 10.1021/acs.chemrestox.6b00347. Epub 2016 Dec 9. PMID: 27933809; PMCID: PMC5396026.", + "otherId": "0", + "citationId": 266, + "otherSource": "" + } + }, + { + "aeid": 767, + "assayComponentEndpointName": "TOX21_Aromatase_Inhibition", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_Aromatase_Inhibition was analyzed into 1 assay endpoint. This assay endpoint, TOX21_Aromatase_Inhibition, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene CYP19A1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is steroidogenesis-related.", + "assayFunctionType": "inducer", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Letrozole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "steroidogenesis-related", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 504, + "assayComponentName": "TOX21_Aromatase_Inhibition", + "assayComponentDesc": "TOX21_Aromatase_Inhibition is one of one assay component(s) measured or calculated from the TOX21_Aromatase_Inhibition assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] are indicative of changes in transcriptional gene expression due to modulation of the human cytochrome P450, family 19, subfamily A, polypeptide 1 [GeneSymbol:CYP19A1 | GeneID:1588 | Uniprot_SwissProt_Accession:P11511].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 314, + "assayName": "TOX21_Aromatase_Inhibition", + "assayDesc": "TOX21_Aromatase_Inhibition is a cell-based, single-readout assay that uses MCF-7, a human breast cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 94, + "geneName": "cytochrome P450, family 19, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP19A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1588, + "officialSymbol": "CYP19A1", + "officialFullName": "cytochrome P450, family 19, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "P11511" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfu023", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24496634", + "pmid": 24496634, + "title": "AroER tri-screen is a biologically relevant assay for endocrine disrupting chemicals modulating the activity of aromatase and/or the estrogen receptor", + "author": "Chen S, Zhou D, Hsin LY, Kanaya N, Wong C, Yip R, Sakamuru S, Xia M, Yuan YC, Witt K, Teng C", + "citation": "Chen S, Zhou D, Hsin LY, Kanaya N, Wong C, Yip R, Sakamuru S, Xia M, Yuan YC, Witt K, Teng C. AroER tri-screen is a biologically relevant assay for endocrine disrupting chemicals modulating the activity of aromatase and/or the estrogen receptor. Toxicol Sci. 2014 May;139(1):198-209. doi: 10.1093/toxsci/kfu023. Epub 2014 Feb 4. PubMed PMID: 24496634; PubMed Central PMCID: PMC4038786.", + "otherId": "0", + "citationId": 222, + "otherSource": "" + } + }, + { + "aeid": 768, + "assayComponentEndpointName": "TOX21_Aromatase_Inhibition_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_Aromatase_Inhibition_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 505, + "assayComponentName": "TOX21_Aromatase_Inhibition_viability", + "assayComponentDesc": "TOX21_Aromatase_Inhibition_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 314, + "assayName": "TOX21_Aromatase_Inhibition", + "assayDesc": "TOX21_Aromatase_Inhibition is a cell-based, single-readout assay that uses MCF-7, a human breast cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "MCF7", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfu023", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24496634", + "pmid": 24496634, + "title": "AroER tri-screen is a biologically relevant assay for endocrine disrupting chemicals modulating the activity of aromatase and/or the estrogen receptor", + "author": "Chen S, Zhou D, Hsin LY, Kanaya N, Wong C, Yip R, Sakamuru S, Xia M, Yuan YC, Witt K, Teng C", + "citation": "Chen S, Zhou D, Hsin LY, Kanaya N, Wong C, Yip R, Sakamuru S, Xia M, Yuan YC, Witt K, Teng C. AroER tri-screen is a biologically relevant assay for endocrine disrupting chemicals modulating the activity of aromatase and/or the estrogen receptor. Toxicol Sci. 2014 May;139(1):198-209. doi: 10.1093/toxsci/kfu023. Epub 2014 Feb 4. PubMed PMID: 24496634; PubMed Central PMCID: PMC4038786.", + "otherId": "0", + "citationId": 222, + "otherSource": "" + } + }, + { + "aeid": 769, + "assayComponentEndpointName": "TOX21_AutoFluor_HEK293_Cell_blue", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AutoFluor_HEK293_Cell_blue was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AutoFluor_HEK293_Cell_blue, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of background reporter, gain-of-signal activity can be used to understand changes in the background control. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is artifact fluorescence.", + "assayFunctionType": "background control", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Fluorescein;Rose Bengal Sodium;Triamterene", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 506, + "assayComponentName": "TOX21_AutoFluor_HEK293_Cell_blue", + "assayComponentDesc": "TOX21_AutoFluor_HEK293_Cell_blue is one of 6 assay component(s) measured or calculated from the TOX21_AutoFluor_HEK293 assay. It is designed to make measurements of artifacts, a form of background reporter, as detected with fluorescence intensity signals by Autofluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Autofluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 315, + "assayName": "TOX21_AutoFluor_HEK293", + "assayDesc": "TOX21_AutoFluor_HEK293 is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-020-60747-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/32132587/", + "pmid": 32132587, + "title": "High-Throughput Screening to Predict Chemical-Assay Interference", + "author": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC", + "citation": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC. High-Throughput Screening to Predict Chemical-Assay Interference. Sci Rep. 2020 Mar 4;10(1):3986. doi: 10.1038/s41598-020-60747-3. PMID: 32132587; PMCID: PMC7055224.", + "otherId": "0", + "citationId": 276, + "otherSource": "" + } + }, + { + "aeid": 770, + "assayComponentEndpointName": "TOX21_AutoFluor_HEK293_Cell_green", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AutoFluor_HEK293_Cell_green was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AutoFluor_HEK293_Cell_green, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of background reporter, gain-of-signal activity can be used to understand changes in the background control. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is artifact fluorescence.", + "assayFunctionType": "background control", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Fluorescein;Rose Bengal Sodium;Triamterene", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 507, + "assayComponentName": "TOX21_AutoFluor_HEK293_Cell_green", + "assayComponentDesc": "TOX21_AutoFluor_HEK293_Cell_green is one of 6 assay component(s) measured or calculated from the TOX21_AutoFluor_HEK293 assay. It is designed to make measurements of artifacts, a form of background reporter, as detected with fluorescence intensity signals by Autofluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Autofluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 315, + "assayName": "TOX21_AutoFluor_HEK293", + "assayDesc": "TOX21_AutoFluor_HEK293 is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-020-60747-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/32132587/", + "pmid": 32132587, + "title": "High-Throughput Screening to Predict Chemical-Assay Interference", + "author": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC", + "citation": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC. High-Throughput Screening to Predict Chemical-Assay Interference. Sci Rep. 2020 Mar 4;10(1):3986. doi: 10.1038/s41598-020-60747-3. PMID: 32132587; PMCID: PMC7055224.", + "otherId": "0", + "citationId": 276, + "otherSource": "" + } + }, + { + "aeid": 771, + "assayComponentEndpointName": "TOX21_AutoFluor_HEK293_Cell_red", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AutoFluor_HEK293_Cell_red was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AutoFluor_HEK293_Cell_red, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of background reporter, gain-of-signal activity can be used to understand changes in the background control. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is artifact fluorescence.", + "assayFunctionType": "background control", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Fluorescein;Rose Bengal Sodium;Triamterene", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 508, + "assayComponentName": "TOX21_AutoFluor_HEK293_Cell_red", + "assayComponentDesc": "TOX21_AutoFluor_HEK293_Cell_red is one of 6 assay component(s) measured or calculated from the TOX21_AutoFluor_HEK293 assay. It is designed to make measurements of artifacts, a form of background reporter, as detected with fluorescence intensity signals by Autofluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Autofluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 315, + "assayName": "TOX21_AutoFluor_HEK293", + "assayDesc": "TOX21_AutoFluor_HEK293 is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-020-60747-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/32132587/", + "pmid": 32132587, + "title": "High-Throughput Screening to Predict Chemical-Assay Interference", + "author": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC", + "citation": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC. High-Throughput Screening to Predict Chemical-Assay Interference. Sci Rep. 2020 Mar 4;10(1):3986. doi: 10.1038/s41598-020-60747-3. PMID: 32132587; PMCID: PMC7055224.", + "otherId": "0", + "citationId": 276, + "otherSource": "" + } + }, + { + "aeid": 772, + "assayComponentEndpointName": "TOX21_AutoFluor_HEK293_Media_blue", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AutoFluor_HEK293_Media_blue was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AutoFluor_HEK293_Media_blue, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of background reporter, gain-of-signal activity can be used to understand changes in the background control. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is artifact fluorescence.", + "assayFunctionType": "background control", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Fluorescein;Rose Bengal Sodium;Triamterene", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 509, + "assayComponentName": "TOX21_AutoFluor_HEK293_Media_blue", + "assayComponentDesc": "TOX21_AutoFluor_HEK293_Media_blue is one of 6 assay component(s) measured or calculated from the TOX21_AutoFluor_HEK293 assay. It is designed to make measurements of artifacts, a form of background reporter, as detected with fluorescence intensity signals by Autofluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Autofluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 315, + "assayName": "TOX21_AutoFluor_HEK293", + "assayDesc": "TOX21_AutoFluor_HEK293 is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-020-60747-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/32132587/", + "pmid": 32132587, + "title": "High-Throughput Screening to Predict Chemical-Assay Interference", + "author": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC", + "citation": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC. High-Throughput Screening to Predict Chemical-Assay Interference. Sci Rep. 2020 Mar 4;10(1):3986. doi: 10.1038/s41598-020-60747-3. PMID: 32132587; PMCID: PMC7055224.", + "otherId": "0", + "citationId": 276, + "otherSource": "" + } + }, + { + "aeid": 773, + "assayComponentEndpointName": "TOX21_AutoFluor_HEK293_Media_green", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AutoFluor_HEK293_Media_green was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AutoFluor_HEK293_Media_green, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of background reporter, gain-of-signal activity can be used to understand changes in the background control. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is artifact fluorescence.", + "assayFunctionType": "background control", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Fluorescein;Rose Bengal Sodium;Triamterene", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 510, + "assayComponentName": "TOX21_AutoFluor_HEK293_Media_green", + "assayComponentDesc": "TOX21_AutoFluor_HEK293_Media_green is one of 6 assay component(s) measured or calculated from the TOX21_AutoFluor_HEK293 assay. It is designed to make measurements of artifacts, a form of background reporter, as detected with fluorescence intensity signals by Autofluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Autofluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 315, + "assayName": "TOX21_AutoFluor_HEK293", + "assayDesc": "TOX21_AutoFluor_HEK293 is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-020-60747-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/32132587/", + "pmid": 32132587, + "title": "High-Throughput Screening to Predict Chemical-Assay Interference", + "author": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC", + "citation": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC. High-Throughput Screening to Predict Chemical-Assay Interference. Sci Rep. 2020 Mar 4;10(1):3986. doi: 10.1038/s41598-020-60747-3. PMID: 32132587; PMCID: PMC7055224.", + "otherId": "0", + "citationId": 276, + "otherSource": "" + } + }, + { + "aeid": 774, + "assayComponentEndpointName": "TOX21_AutoFluor_HEK293_Media_red", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AutoFluor_HEK293_Media_red was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AutoFluor_HEK293_Media_red, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of background reporter, gain-of-signal activity can be used to understand changes in the background control. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is artifact fluorescence.", + "assayFunctionType": "background control", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Fluorescein;Rose Bengal Sodium;Triamterene", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 511, + "assayComponentName": "TOX21_AutoFluor_HEK293_Media_red", + "assayComponentDesc": "TOX21_AutoFluor_HEK293_Media_red is one of 6 assay component(s) measured or calculated from the TOX21_AutoFluor_HEK293 assay. It is designed to make measurements of artifacts, a form of background reporter, as detected with fluorescence intensity signals by Autofluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Autofluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 315, + "assayName": "TOX21_AutoFluor_HEK293", + "assayDesc": "TOX21_AutoFluor_HEK293 is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-020-60747-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/32132587/", + "pmid": 32132587, + "title": "High-Throughput Screening to Predict Chemical-Assay Interference", + "author": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC", + "citation": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC. High-Throughput Screening to Predict Chemical-Assay Interference. Sci Rep. 2020 Mar 4;10(1):3986. doi: 10.1038/s41598-020-60747-3. PMID: 32132587; PMCID: PMC7055224.", + "otherId": "0", + "citationId": 276, + "otherSource": "" + } + }, + { + "aeid": 775, + "assayComponentEndpointName": "TOX21_AutoFluor_HEPG2_Cell_blue", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AutoFluor_HEPG2_Cell_blue was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AutoFluor_HEPG2_Cell_blue, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of background reporter, gain-of-signal activity can be used to understand changes in the background control. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is artifact fluorescence.", + "assayFunctionType": "background control", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Fluorescein;Rose Bengal Sodium;Triamterene", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 512, + "assayComponentName": "TOX21_AutoFluor_HEPG2_Cell_blue", + "assayComponentDesc": "TOX21_AutoFluor_HEPG2_Cell_blue is one of 6 assay component(s) measured or calculated from the TOX21_AutoFluor_HEPG2 assay. It is designed to make measurements of artifacts, a form of background reporter, as detected with fluorescence intensity signals by Autofluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Autofluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 316, + "assayName": "TOX21_AutoFluor_HEPG2", + "assayDesc": "TOX21_AutoFluor_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-020-60747-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/32132587/", + "pmid": 32132587, + "title": "High-Throughput Screening to Predict Chemical-Assay Interference", + "author": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC", + "citation": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC. High-Throughput Screening to Predict Chemical-Assay Interference. Sci Rep. 2020 Mar 4;10(1):3986. doi: 10.1038/s41598-020-60747-3. PMID: 32132587; PMCID: PMC7055224.", + "otherId": "0", + "citationId": 276, + "otherSource": "" + } + }, + { + "aeid": 776, + "assayComponentEndpointName": "TOX21_AutoFluor_HEPG2_Cell_green", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AutoFluor_HEPG2_Cell_green was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AutoFluor_HEPG2_Cell_green, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of background reporter, gain-of-signal activity can be used to understand changes in the background control. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is artifact fluorescence.", + "assayFunctionType": "background control", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Fluorescein;Rose Bengal Sodium;Triamterene", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 513, + "assayComponentName": "TOX21_AutoFluor_HEPG2_Cell_green", + "assayComponentDesc": "TOX21_AutoFluor_HEPG2_Cell_green is one of 6 assay component(s) measured or calculated from the TOX21_AutoFluor_HEPG2 assay. It is designed to make measurements of artifacts, a form of background reporter, as detected with fluorescence intensity signals by Autofluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Autofluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 316, + "assayName": "TOX21_AutoFluor_HEPG2", + "assayDesc": "TOX21_AutoFluor_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-020-60747-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/32132587/", + "pmid": 32132587, + "title": "High-Throughput Screening to Predict Chemical-Assay Interference", + "author": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC", + "citation": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC. High-Throughput Screening to Predict Chemical-Assay Interference. Sci Rep. 2020 Mar 4;10(1):3986. doi: 10.1038/s41598-020-60747-3. PMID: 32132587; PMCID: PMC7055224.", + "otherId": "0", + "citationId": 276, + "otherSource": "" + } + }, + { + "aeid": 777, + "assayComponentEndpointName": "TOX21_AutoFluor_HEPG2_Cell_red", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AutoFluor_HEPG2_Cell_red was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AutoFluor_HEPG2_Cell_red, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of background reporter, gain-of-signal activity can be used to understand changes in the background control. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is artifact fluorescence.", + "assayFunctionType": "background control", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Fluorescein;Rose Bengal Sodium;Triamterene", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 514, + "assayComponentName": "TOX21_AutoFluor_HEPG2_Cell_red", + "assayComponentDesc": "TOX21_AutoFluor_HEPG2_Cell_red is one of 6 assay component(s) measured or calculated from the TOX21_AutoFluor_HEPG2 assay. It is designed to make measurements of artifacts, a form of background reporter, as detected with fluorescence intensity signals by Autofluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Autofluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 316, + "assayName": "TOX21_AutoFluor_HEPG2", + "assayDesc": "TOX21_AutoFluor_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-020-60747-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/32132587/", + "pmid": 32132587, + "title": "High-Throughput Screening to Predict Chemical-Assay Interference", + "author": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC", + "citation": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC. High-Throughput Screening to Predict Chemical-Assay Interference. Sci Rep. 2020 Mar 4;10(1):3986. doi: 10.1038/s41598-020-60747-3. PMID: 32132587; PMCID: PMC7055224.", + "otherId": "0", + "citationId": 276, + "otherSource": "" + } + }, + { + "aeid": 778, + "assayComponentEndpointName": "TOX21_AutoFluor_HEPG2_Media_blue", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AutoFluor_HEPG2_Media_blue was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AutoFluor_HEPG2_Media_blue, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of background reporter, gain-of-signal activity can be used to understand changes in the background control. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is artifact fluorescence.", + "assayFunctionType": "background control", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Fluorescein;Rose Bengal Sodium;Triamterene", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 515, + "assayComponentName": "TOX21_AutoFluor_HEPG2_Media_blue", + "assayComponentDesc": "TOX21_AutoFluor_HEPG2_Media_blue is one of 6 assay component(s) measured or calculated from the TOX21_AutoFluor_HEPG2 assay. It is designed to make measurements of artifacts, a form of background reporter, as detected with fluorescence intensity signals by Autofluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Autofluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 316, + "assayName": "TOX21_AutoFluor_HEPG2", + "assayDesc": "TOX21_AutoFluor_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-020-60747-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/32132587/", + "pmid": 32132587, + "title": "High-Throughput Screening to Predict Chemical-Assay Interference", + "author": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC", + "citation": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC. High-Throughput Screening to Predict Chemical-Assay Interference. Sci Rep. 2020 Mar 4;10(1):3986. doi: 10.1038/s41598-020-60747-3. PMID: 32132587; PMCID: PMC7055224.", + "otherId": "0", + "citationId": 276, + "otherSource": "" + } + }, + { + "aeid": 779, + "assayComponentEndpointName": "TOX21_AutoFluor_HEPG2_Media_green", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AutoFluor_HEPG2_Media_green was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AutoFluor_HEPG2_Media_green, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of background reporter, gain-of-signal activity can be used to understand changes in the background control. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is artifact fluorescence.", + "assayFunctionType": "background control", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Fluorescein;Rose Bengal Sodium;Triamterene", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 516, + "assayComponentName": "TOX21_AutoFluor_HEPG2_Media_green", + "assayComponentDesc": "TOX21_AutoFluor_HEPG2_Media_green is one of 6 assay component(s) measured or calculated from the TOX21_AutoFluor_HEPG2 assay. It is designed to make measurements of artifacts, a form of background reporter, as detected with fluorescence intensity signals by Autofluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Autofluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 316, + "assayName": "TOX21_AutoFluor_HEPG2", + "assayDesc": "TOX21_AutoFluor_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-020-60747-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/32132587/", + "pmid": 32132587, + "title": "High-Throughput Screening to Predict Chemical-Assay Interference", + "author": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC", + "citation": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC. High-Throughput Screening to Predict Chemical-Assay Interference. Sci Rep. 2020 Mar 4;10(1):3986. doi: 10.1038/s41598-020-60747-3. PMID: 32132587; PMCID: PMC7055224.", + "otherId": "0", + "citationId": 276, + "otherSource": "" + } + }, + { + "aeid": 780, + "assayComponentEndpointName": "TOX21_AutoFluor_HEPG2_Media_red", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AutoFluor_HEPG2_Media_red was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AutoFluor_HEPG2_Media_red, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of background reporter, gain-of-signal activity can be used to understand changes in the background control. \r\nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a background control function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is artifact fluorescence.", + "assayFunctionType": "background control", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Fluorescein;Rose Bengal Sodium;Triamterene", + "signalDirection": "gain", + "intendedTargetType": "chemical", + "intendedTargetTypeSub": "physical feature", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "artifact fluorescence", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 517, + "assayComponentName": "TOX21_AutoFluor_HEPG2_Media_red", + "assayComponentDesc": "TOX21_AutoFluor_HEPG2_Media_red is one of 6 assay component(s) measured or calculated from the TOX21_AutoFluor_HEPG2 assay. It is designed to make measurements of artifacts, a form of background reporter, as detected with fluorescence intensity signals by Autofluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals are indicative of the test substance having some physical feature that alters or influences the background fluorescence.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "autofluorescence", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Autofluorescence", + "keyAssayReagentType": "NA", + "keyAssayReagent": "NA", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "physical feature", + "aid": 316, + "assayName": "TOX21_AutoFluor_HEPG2", + "assayDesc": "TOX21_AutoFluor_HEPG2 is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "physicochemical format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41598-020-60747-3", + "url": "https://pubmed.ncbi.nlm.nih.gov/32132587/", + "pmid": 32132587, + "title": "High-Throughput Screening to Predict Chemical-Assay Interference", + "author": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC", + "citation": "Borrel A, Huang R, Sakamuru S, Xia M, Simeonov A, Mansouri K, Houck KA, Judson RS, Kleinstreuer NC. High-Throughput Screening to Predict Chemical-Assay Interference. Sci Rep. 2020 Mar 4;10(1):3986. doi: 10.1038/s41598-020-60747-3. PMID: 32132587; PMCID: PMC7055224.", + "otherId": "0", + "citationId": 276, + "otherSource": "" + } + }, + { + "aeid": 781, + "assayComponentEndpointName": "TOX21_ELG1_LUC_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ELG1_LUC_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ELG1_LUC_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ATAD5. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the hydrolase intended target family, where the subfamily is atpase.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "5-Fluorouridine", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "hydrolase", + "intendedTargetFamilySub": "atpase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 518, + "assayComponentName": "TOX21_ELG1_LUC_Agonist", + "assayComponentDesc": "TOX21_ELG1_LUC_Agonist is one of one assay component(s) measured or calculated from the TOX21_ELG1_LUC_Agonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human ATPase family, AAA domain containing 5 [GeneSymbol:ATAD5 | GeneID:79915 | Uniprot_SwissProt_Accession:Q96QE3].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 317, + "assayName": "TOX21_ELG1_LUC_Agonist", + "assayDesc": "TOX21_ELG1_LUC_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 435, + "geneName": "ATPase family, AAA domain containing 5", + "description": null, + "geneSymbol": "ATAD5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 79915, + "officialSymbol": "ATAD5", + "officialFullName": "ATPase family, AAA domain containing 5", + "uniprotAccessionNumber": "Q96QE3" + }, + "assayList": null, + "citations": null + }, + { + "aeid": 782, + "assayComponentEndpointName": "TOX21_ELG1_LUC_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_ELG1_LUC_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 519, + "assayComponentName": "TOX21_ELG1_LUC_Agonist_viability", + "assayComponentDesc": "TOX21_ELG1_LUC_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 317, + "assayName": "TOX21_ELG1_LUC_Agonist", + "assayDesc": "TOX21_ELG1_LUC_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": null + }, + { + "aeid": 783, + "assayComponentEndpointName": "TOX21_ERa_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERa_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERa_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 520, + "assayComponentName": "TOX21_ERa_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_ERa_BLA_Agonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ERa_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to ESR1 gene(s) using a positive control of 17b-estradiol", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 318, + "assayName": "TOX21_ERa_BLA_Agonist", + "assayDesc": "TOX21_ERa_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 784, + "assayComponentEndpointName": "TOX21_ERa_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERa_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERa_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene ESR1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 521, + "assayComponentName": "TOX21_ERa_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_ERa_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_ERa_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor (steroidal) activity at the protein (receptor) level, specifically mapping to ESR1 gene(s) using a positive control of 17b-estradiol", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 318, + "assayName": "TOX21_ERa_BLA_Agonist", + "assayDesc": "TOX21_ERa_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 785, + "assayComponentEndpointName": "TOX21_ERa_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERa_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERa_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity.\r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 522, + "assayComponentName": "TOX21_ERa_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_ERa_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_ERa_BLA_Agonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to ESR1 gene(s) using a positive control of 17b-estradiol", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 318, + "assayName": "TOX21_ERa_BLA_Agonist", + "assayDesc": "TOX21_ERa_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 786, + "assayComponentEndpointName": "TOX21_ERa_BLA_Antagonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERa_BLA_Antagonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERa_BLA_Antagonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4-hydroxytamoxifen", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 523, + "assayComponentName": "TOX21_ERa_BLA_Antagonist_ratio", + "assayComponentDesc": "TOX21_ERa_BLA_Antagonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_ERa_BLA_Antagonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to ESR1 gene(s) using a positive control of 4-hydroxytamoxifen", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 319, + "assayName": "TOX21_ERa_BLA_Antagonist", + "assayDesc": "TOX21_ERa_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 787, + "assayComponentEndpointName": "TOX21_ERa_BLA_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_ERa_BLA_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 524, + "assayComponentName": "TOX21_ERa_BLA_Antagonist_viability", + "assayComponentDesc": "TOX21_ERa_BLA_Antagonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 319, + "assayName": "TOX21_ERa_BLA_Antagonist", + "assayDesc": "TOX21_ERa_BLA_Antagonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 788, + "assayComponentEndpointName": "TOX21_ERa_LUC_VM7_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERa_LUC_VM7_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERa_LUC_VM7_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR1. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "17b-Estradiol", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 525, + "assayComponentName": "TOX21_ERa_LUC_VM7_Agonist", + "assayComponentDesc": "TOX21_ERa_LUC_VM7_Agonist is one of one assay component(s) measured or calculated from the TOX21_ERa_LUC_VM7_Agonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "TOX21_ERa_LUC_VM7_Agonist was designed to measure changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo]. Changes are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 320, + "assayName": "TOX21_ERa_LUC_VM7_Agonist", + "assayDesc": "TOX21_ERa_LUC_VM7_Agonist is a cell-based, single-readout assay that uses VM7, a human breast tissue cell line, with measurements taken at 22 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 22.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfv168", + "url": "https://pubmed.ncbi.nlm.nih.gov/26272952/", + "pmid": 26272952, + "title": "Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor", + "author": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS", + "citation": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS. Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor. Toxicol Sci. 2015 Nov;148(1):137-54. doi: 10.1093/toxsci/kfv168. Epub 2015 Aug 13. PMID: 26272952; PMCID: PMC4635633.", + "otherId": "0", + "citationId": 277, + "otherSource": "" + } + }, + { + "aeid": 789, + "assayComponentEndpointName": "TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene ESR1. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "4-hydroxytamoxifen", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 526, + "assayComponentName": "TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2", + "assayComponentDesc": "TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2 is one of one assay component(s) measured or calculated from the TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2 assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] are indicative of changes in transcriptional gene expression due to antagonist activity regulated by the human estrogen receptor 1 [GeneSymbol:ESR1 | GeneID:2099 | Uniprot_SwissProt_Accession:P03372] using a positive control of 4-hydroxytamoxifen", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 321, + "assayName": "TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2", + "assayDesc": "TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2 is a cell-based, single-readout assay that uses VM7, a human breast tissue cell line, with measurements taken at 22 hours after chemical dosing in a 1536-well plate. This is a secondary assay for specificity to TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2.", + "timepointHr": 22.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP ER", + "description": "Estrogen receptor assays used in EDSP models" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfv168", + "url": "https://pubmed.ncbi.nlm.nih.gov/26272952/", + "pmid": 26272952, + "title": "Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor", + "author": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS", + "citation": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS. Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor. Toxicol Sci. 2015 Nov;148(1):137-54. doi: 10.1093/toxsci/kfv168. Epub 2015 Aug 13. PMID: 26272952; PMCID: PMC4635633.", + "otherId": "0", + "citationId": 277, + "otherSource": "" + } + }, + { + "aeid": 790, + "assayComponentEndpointName": "TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 527, + "assayComponentName": "TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2_viability", + "assayComponentDesc": "TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 321, + "assayName": "TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2", + "assayDesc": "TOX21_ERa_LUC_VM7_Antagonist_0.5nM_E2 is a cell-based, single-readout assay that uses VM7, a human breast tissue cell line, with measurements taken at 22 hours after chemical dosing in a 1536-well plate. This is a secondary assay for specificity to TOX21_ERa_LUC_VM7_Antagonist_0.1nM_E2.", + "timepointHr": 22.0, + "organismId": 9606, + "organism": "human", + "tissue": "breast", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "VM7", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfv168", + "url": "https://pubmed.ncbi.nlm.nih.gov/26272952/", + "pmid": 26272952, + "title": "Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor", + "author": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS", + "citation": "Judson RS, Magpantay FM, Chickarmane V, Haskell C, Tania N, Taylor J, Xia M, Huang R, Rotroff DM, Filer DL, Houck KA, Martin MT, Sipes N, Richard AM, Mansouri K, Setzer RW, Knudsen TB, Crofton KM, Thomas RS. Integrated Model of Chemical Perturbations of a Biological Pathway Using 18 In Vitro High-Throughput Screening Assays for the Estrogen Receptor. Toxicol Sci. 2015 Nov;148(1):137-54. doi: 10.1093/toxsci/kfv168. Epub 2015 Aug 13. PMID: 26272952; PMCID: PMC4635633.", + "otherId": "0", + "citationId": 277, + "otherSource": "" + } + }, + { + "aeid": 791, + "assayComponentEndpointName": "TOX21_GR_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_GR_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_GR_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR3C1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Dexamethasone", + "signalDirection": "loss", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 528, + "assayComponentName": "TOX21_GR_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_GR_BLA_Agonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_GR_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR3C1 gene(s) using a positive control of Dexamethasone", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 322, + "assayName": "TOX21_GR_BLA_Agonist", + "assayDesc": "TOX21_GR_BLA_Agonist is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 792, + "assayComponentEndpointName": "TOX21_GR_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_GR_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_GR_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene NR3C1. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Dexamethasone", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 529, + "assayComponentName": "TOX21_GR_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_GR_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_GR_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor (non-steroidal) activity at the protein (receptor) level, specifically mapping to NR3C1 gene(s) using a positive control of Dexamethasone", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 322, + "assayName": "TOX21_GR_BLA_Agonist", + "assayDesc": "TOX21_GR_BLA_Agonist is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 793, + "assayComponentEndpointName": "TOX21_GR_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_GR_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_GR_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR3C1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Dexamethasone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 530, + "assayComponentName": "TOX21_GR_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_GR_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_GR_BLA_Agonist_ratio was designed to target nuclear receptor (non-steroidal) activity at the protein (receptor) level, specifically mapping to NR3C1 gene(s) using a positive control of Dexamethasone", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 322, + "assayName": "TOX21_GR_BLA_Agonist", + "assayDesc": "TOX21_GR_BLA_Agonist is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 794, + "assayComponentEndpointName": "TOX21_GR_BLA_Antagonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_GR_BLA_Antagonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_GR_BLA_Antagonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene NR3C1. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand gene activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is steroidal.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Mifeprostone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 531, + "assayComponentName": "TOX21_GR_BLA_Antagonist_ratio", + "assayComponentDesc": "TOX21_GR_BLA_Antagonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity.", + "assayComponentTargetDesc": "TOX21_GR_BLA_Antagonist_ratio was designed to target nuclear receptor activity at the protein (receptor) level, specifically mapping to NR3C1 gene(s) using a positive control of Mifepristone", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 323, + "assayName": "TOX21_GR_BLA_Antagonist", + "assayDesc": "TOX21_GR_BLA_Antagonist is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 795, + "assayComponentEndpointName": "TOX21_GR_BLA_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_GR_BLA_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 532, + "assayComponentName": "TOX21_GR_BLA_Antagonist_viability", + "assayComponentDesc": "TOX21_GR_BLA_Antagonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 323, + "assayName": "TOX21_GR_BLA_Antagonist", + "assayDesc": "TOX21_GR_BLA_Antagonist is a cell-based, single-readout assay that uses HeLa, a human cervix cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "cervix", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HeLa", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 796, + "assayComponentEndpointName": "TOX21_MMP_fitc", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_MMP_fitc is an assay readout measuring signaling via mitochondrial depolarization and designed using viability reporter (mitochondrial membrane potential) detected with immunofluorescence. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "signaling", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "FCCP", + "signalDirection": "gain", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 533, + "assayComponentName": "TOX21_MMP_fitc", + "assayComponentDesc": "TOX21_MMP_fitc is an assay readout measuring signaling via mitochondrial depolarization and designed using background reporter (mitochondrial membrane potential) detected with immunofluorescence.", + "assayComponentTargetDesc": "TOX21_MMP_fitc was designed to target cell morphology (organelle conformation) activity at the cellular (cellular) level, specifically mapping to NA gene(s) using a positive control of FCCP", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "mitochondrial depolarization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "homogenous mitochondrial membrane potential assay", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Mito-MPS", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 324, + "assayName": "TOX21_MMP", + "assayDesc": "TOX21_MMP (Mitochondrial Membrane Potential) is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1152/physiolgenomics.00161.2011", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/22433785", + "pmid": 22433785, + "title": "Application of a homogenous membrane potential assay to assess mitochondrial function", + "author": "Sakamuru S, Li X, Attene-Ramos MS, Huang R, Lu J, Shou L, Shen M, Tice RR, Austin CP, Xia M", + "citation": "Sakamuru S, Li X, Attene-Ramos MS, Huang R, Lu J, Shou L, Shen M, Tice RR, Austin CP, Xia M. Application of a homogenous membrane potential assay to assess mitochondrial function. Physiol Genomics. 2012 May 1;44(9):495-503. doi: 10.1152/physiolgenomics.00161.2011. Epub 2012 Mar 20. PubMed PMID: 22433785; PubMed Central PMCID: PMC3426425.", + "otherId": "0", + "citationId": 219, + "otherSource": "" + } + }, + { + "aeid": 798, + "assayComponentEndpointName": "TOX21_MMP_rhodamine", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_MMP_rhodamine is an assay readout measuring signaling via mitochondrial depolarization and designed using viability reporter (mitochondrial membrane potential) detected with immunofluorescence. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "signaling", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "FCCP", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "mitochondria", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 535, + "assayComponentName": "TOX21_MMP_rhodamine", + "assayComponentDesc": "TOX21_MMP_rhodamine is an assay readout measuring signaling via mitochondrial depolarization and designed using viability reporter (mitochondrial membrane potential) detected with immunofluorescence.", + "assayComponentTargetDesc": "TOX21_MMP_rhodamine was designed to target cell morphology (organelle conformation) activity at the cellular (cellular) level, specifically mapping to NA gene(s) using a positive control of FCCP", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "mitochondrial depolarization", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "homogenous mitochondrial membrane potential assay", + "keyAssayReagentType": "stain", + "keyAssayReagent": "Mito-MPS", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "mitochondria", + "aid": 324, + "assayName": "TOX21_MMP", + "assayDesc": "TOX21_MMP (Mitochondrial Membrane Potential) is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1152/physiolgenomics.00161.2011", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/22433785", + "pmid": 22433785, + "title": "Application of a homogenous membrane potential assay to assess mitochondrial function", + "author": "Sakamuru S, Li X, Attene-Ramos MS, Huang R, Lu J, Shou L, Shen M, Tice RR, Austin CP, Xia M", + "citation": "Sakamuru S, Li X, Attene-Ramos MS, Huang R, Lu J, Shou L, Shen M, Tice RR, Austin CP, Xia M. Application of a homogenous membrane potential assay to assess mitochondrial function. Physiol Genomics. 2012 May 1;44(9):495-503. doi: 10.1152/physiolgenomics.00161.2011. Epub 2012 Mar 20. PubMed PMID: 22433785; PubMed Central PMCID: PMC3426425.", + "otherId": "0", + "citationId": 219, + "otherSource": "" + } + }, + { + "aeid": 799, + "assayComponentEndpointName": "TOX21_MMP_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_MMP_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 536, + "assayComponentName": "TOX21_MMP_viability", + "assayComponentDesc": "TOX21_MMP_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 324, + "assayName": "TOX21_MMP", + "assayDesc": "TOX21_MMP (Mitochondrial Membrane Potential) is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1152/physiolgenomics.00161.2011", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/22433785", + "pmid": 22433785, + "title": "Application of a homogenous membrane potential assay to assess mitochondrial function", + "author": "Sakamuru S, Li X, Attene-Ramos MS, Huang R, Lu J, Shou L, Shen M, Tice RR, Austin CP, Xia M", + "citation": "Sakamuru S, Li X, Attene-Ramos MS, Huang R, Lu J, Shou L, Shen M, Tice RR, Austin CP, Xia M. Application of a homogenous membrane potential assay to assess mitochondrial function. Physiol Genomics. 2012 May 1;44(9):495-503. doi: 10.1152/physiolgenomics.00161.2011. Epub 2012 Mar 20. PubMed PMID: 22433785; PubMed Central PMCID: PMC3426425.", + "otherId": "0", + "citationId": 219, + "otherSource": "" + } + }, + { + "aeid": 800, + "assayComponentEndpointName": "TOX21_PPARg_BLA_Agonist_ch1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PPARg_BLA_Agonist_ch1 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PPARg_BLA_Agonist_ch1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene PPARG. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "substrate", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rosiglitazone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "channel 1", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 537, + "assayComponentName": "TOX21_PPARg_BLA_Agonist_ch1", + "assayComponentDesc": "TOX21_PPARg_BLA_Agonist_ch1 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the uncleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_PPARg_BLA_Agonist_ch1 was designed to measure uncleaved reporter gene substrate to target nuclear receptor activity at the protein (receptor) level, specifically mapping to PPARG gene(s) using a positive control of Rosiglitazone.", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 325, + "assayName": "TOX21_PPARg_BLA_Agonist", + "assayDesc": "TOX21_PPARg_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 801, + "assayComponentEndpointName": "TOX21_PPARg_BLA_Agonist_ch2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PPARg_BLA_Agonist_ch2 was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PPARg_BLA_Agonist_ch2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, increased activity can be used to understand changes in the reporter gene as they relate to the gene PPARG. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves as artifact detection function.", + "assayFunctionType": "product", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rosiglitazone", + "signalDirection": "gain", + "intendedTargetType": "pathway", + "intendedTargetTypeSub": "pathway-specified", + "intendedTargetFamily": "channel 2", + "intendedTargetFamilySub": "baseline control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 538, + "assayComponentName": "TOX21_PPARg_BLA_Agonist_ch2", + "assayComponentDesc": "TOX21_PPARg_BLA_Agonist_ch2 is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the cleaved reporter gene substrate and is used to calculate the ratio of cleaved (ch2) to uncleaved (ch1) substrate used as the measure of target activity. ", + "assayComponentTargetDesc": "TOX21_PPARg_BLA_Agonist_ch2 was designed to measure cleaved reporter gene substrate to target nuclear receptor (non-steroidal) activity at the protein (receptor) level, specifically mapping to PPARG gene(s) using a positive control of Rosiglitazone", + "parameterReadoutType": "single", + "assayDesignType": "background reporter", + "assayDesignTypeSub": "artifact detection", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 325, + "assayName": "TOX21_PPARg_BLA_Agonist", + "assayDesc": "TOX21_PPARg_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 802, + "assayComponentEndpointName": "TOX21_PPARg_BLA_Agonist_ratio", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_PPARg_BLA_Agonist_ratio was analyzed into 1 assay endpoint. This assay endpoint, TOX21_PPARg_BLA_Agonist_ratio, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene PPARG. Furthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints and this ratio serves a reporter gene function to understand target activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "ratio", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Rosiglitazone", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 539, + "assayComponentName": "TOX21_PPARg_BLA_Agonist_ratio", + "assayComponentDesc": "TOX21_PPARg_BLA_Agonist_ratio is an assay readout measuring reporter gene via receptor activity and designed using inducible reporter (beta lactamase induction) detected with GAL4 b-lactamase reporter gene. The signal is derived from the ratio of cleaved (ch2) to uncleaved (ch1) reporter gene substrate used as the measure of target activity..", + "assayComponentTargetDesc": "TOX21_PPARg_BLA_Agonist_ratio was designed to target nuclear receptor (non-steroidal) activity at the protein (receptor) level, specifically mapping to PPARG gene(s) using a positive control of Rosiglitazone", + "parameterReadoutType": "multiple", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "beta lactamase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "GAL4 b-lactamase reporter gene", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CCF4-AM", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 325, + "assayName": "TOX21_PPARg_BLA_Agonist", + "assayDesc": "TOX21_PPARg_BLA_Agonist is a cell-based, single-readout assay that uses HEK293T, a human kidney cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "kidney", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HEK293T", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 250, + "geneName": "peroxisome proliferator-activated receptor gamma", + "description": null, + "geneSymbol": "PPARG", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5468, + "officialSymbol": "PPARG", + "officialFullName": "peroxisome proliferator-activated receptor gamma", + "uniprotAccessionNumber": "P37231" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1289/ehp.1002952", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21543282", + "pmid": 21543282, + "title": "Chemical genomics profiling of environmental chemical modulation of human nuclear receptors", + "author": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP", + "citation": "Huang R, Xia M, Cho MH, Sakamuru S, Shinn P, Houck KA, Dix DJ, Judson RS, Witt KL, Kavlock RJ, Tice RR, Austin CP. Chemical genomics profiling of environmental chemical modulation of human nuclear receptors. Environ Health Perspect. 2011 Aug;119(8):1142-8. doi: 10.1289/ehp.1002952. Epub 2011 May 4. PubMed PMID: 21543282; PubMed Central PMCID: PMC3237348.", + "otherId": "0", + "citationId": 221, + "otherSource": "" + } + }, + { + "aeid": 803, + "assayComponentEndpointName": "TOX21_TR_LUC_GH3_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TR_LUC_GH3_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TR_LUC_GH3_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRA and THRB. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "0.092 uM T3", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 540, + "assayComponentName": "TOX21_TR_LUC_GH3_Agonist", + "assayComponentDesc": "TOX21_TR_LUC_GH3_Agonist is one of one assay component(s) measured or calculated from the TOX21_TR_LUC_GH3_Agonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] are indicative of changes in transcriptional gene expression due to agonist activity regulated by the human thyroid hormone receptor, alpha and thyroid hormone receptor, beta [GeneSymbol:THRA & THRB | GeneID:7067 & 7068 | Uniprot_SwissProt_Accession:P10827 & P10828]. Thyroid receptor (TR), a nuclear hormone receptor, plays an important role in development, proliferation, differentiation, metabolism, brain function, and cardiovascular system. TR-interacting compounds have been shown to disrupt thyroid homeostasis.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 326, + "assayName": "TOX21_TR_LUC_GH3_Agonist", + "assayDesc": "TOX21_TR_LUC_GH3_Agonist is a cell-based, single-readout assay that uses GH3, a rat pituitary gland cell line, with measurements taken at 28 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 28.0, + "organismId": 10116, + "organism": "rat", + "tissue": "pituitary gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "GH3", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 1.0, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 321, + "geneName": "thyroid hormone receptor, alpha", + "description": null, + "geneSymbol": "THRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7067, + "officialSymbol": "THRA", + "officialFullName": "thyroid hormone receptor, alpha", + "uniprotAccessionNumber": "P10827" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.2174/2213988501408010036", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24772387", + "pmid": 24772387, + "title": "Identification of thyroid hormone receptor active compounds using a quantitative high-throughput screening platform", + "author": "Freitas J, Miller N, Mengeling BJ, Xia M, Huang R, Houck K, Rietjens IM, Furlow JD, Murk AJ", + "citation": "Freitas J, Miller N, Mengeling BJ, Xia M, Huang R, Houck K, Rietjens IM, Furlow JD, Murk AJ. Identification of thyroid hormone receptor active compounds using a quantitative high-throughput screening platform. Curr Chem Genomics Transl Med. 2014 Mar 7;8:36-46. doi: 10.2174/2213988501408010036. eCollection 2014. PubMed PMID: 24772387; PubMed Central PMCID: PMC3999704.", + "otherId": "0", + "citationId": 223, + "otherSource": "" + } + }, + { + "aeid": 228, + "assayComponentEndpointName": "BSK_CASM3C_Thrombomodulin", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_Thrombomodulin was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3C_Thrombomodulin, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene THBD. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 155, + "assayComponentName": "BSK_CASM3C_Thrombomodulin", + "assayComponentDesc": "BSK_CASM3C_Thrombomodulin is an assay component measured in the BSK_CASM3C assay. It measures Thrombomodulin antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Thrombomodulin antibody is used to tag and quantify the level of thrombomodulin protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:THBD | GeneID:7056 | Uniprot_SwissProt_Accession:P07204].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Thrombomodulin antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 320, + "geneName": "thrombomodulin", + "description": null, + "geneSymbol": "THBD", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7056, + "officialSymbol": "THBD", + "officialFullName": "thrombomodulin", + "uniprotAccessionNumber": "P07204" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 230, + "assayComponentEndpointName": "BSK_CASM3C_TissueFactor", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_TissueFactor was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3C_TissueFactor, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene F3. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is coagulation factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "coagulation factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 156, + "assayComponentName": "BSK_CASM3C_TissueFactor", + "assayComponentDesc": "BSK_CASM3C_TissueFactor is an assay component measured in the BSK_CASM3C assay. It measures Tissue Factor antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Tissue Factor antibody is used to tag and quantify the level of coagulation factor III (thromboplastin, tissue factor) protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:F3 | GeneID:2152 | Uniprot_SwissProt_Accession:P13726].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Tissue Factor antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 123, + "geneName": "coagulation factor III (thromboplastin, tissue factor)", + "description": null, + "geneSymbol": "F3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2152, + "officialSymbol": "F3", + "officialFullName": "coagulation factor III (thromboplastin, tissue factor)", + "uniprotAccessionNumber": "P13726" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 232, + "assayComponentEndpointName": "BSK_CASM3C_uPAR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3CAR was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3CAR, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene PLAUR. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is plasmogen activator.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "plasmogen activator", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 157, + "assayComponentName": "BSK_CASM3C_uPAR", + "assayComponentDesc": "BSK_CASM3CAR is an assay component measured in the BSK_CASM3C assay. It measures uPAR antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "uPAR antibody is used to tag and quantify the level of plasminogen activator, urokinase receptor protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:PLAUR | GeneID:5329 | Uniprot_SwissProt_Accession:Q03405].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "uPAR antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 241, + "geneName": "plasminogen activator, urokinase receptor", + "description": null, + "geneSymbol": "PLAUR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5329, + "officialSymbol": "PLAUR", + "officialFullName": "plasminogen activator, urokinase receptor", + "uniprotAccessionNumber": "Q03405" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 234, + "assayComponentEndpointName": "BSK_CASM3C_VCAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_VCAM1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3C_VCAM1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene VCAM1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is Immunoglobulin CAM.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 158, + "assayComponentName": "BSK_CASM3C_VCAM1", + "assayComponentDesc": "BSK_CASM3C_VCAM1 is an assay component measured in the BSK_CASM3C assay. It measures VCAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "VCAM-1 antibody is used to tag and quantify the level of vascular cell adhesion molecule 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:VCAM1 | GeneID:7412 | Uniprot_SwissProt_Accession:P19320].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "VCAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 334, + "geneName": "vascular cell adhesion molecule 1", + "description": null, + "geneSymbol": "VCAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7412, + "officialSymbol": "VCAM1", + "officialFullName": "vascular cell adhesion molecule 1", + "uniprotAccessionNumber": "P19320" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 236, + "assayComponentEndpointName": "BSK_hDFCGF_CollagenIII", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_CollagenIII was analyzed into 1 assay endpoint. This assay endpoint, BSK_hDFCGF_CollagenIII, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene COL3A1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is collagen.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "collagen", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 159, + "assayComponentName": "BSK_hDFCGF_CollagenIII", + "assayComponentDesc": "BSK_hDFCGF_CollagenIII is an assay component measured in the BSK_hDFCGF assay. It measures Collagen antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "Collagen antibody is used to tag and quantify the level of collagen, type III, alpha 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and growth factors [GeneSymbol:COL3A1 | GeneID:1281 | Uniprot_SwissProt_Accession:P02461].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "Collagen antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 70, + "geneName": "collagen, type III, alpha 1", + "description": null, + "geneSymbol": "COL3A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1281, + "officialSymbol": "COL3A1", + "officialFullName": "collagen, type III, alpha 1", + "uniprotAccessionNumber": "P02461" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 238, + "assayComponentEndpointName": "BSK_hDFCGF_EGFR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_EGFR was analyzed into 1 assay endpoint. This assay endpoint, BSK_hDFCGF_EGFR, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene EGFR. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 160, + "assayComponentName": "BSK_hDFCGF_EGFR", + "assayComponentDesc": "BSK_hDFCGF_EGFR is an assay component measured in the BSK_hDFCGF assay. It measures EGFR antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "EGFR antibody is used to tag and quantify the level of epidermal growth factor receptor protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and growth factors [GeneSymbol:EGFR | GeneID:1956 | Uniprot_SwissProt_Accession:P00533].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "EGFR antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 108, + "geneName": "epidermal growth factor receptor", + "description": null, + "geneSymbol": "EGFR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1956, + "officialSymbol": "EGFR", + "officialFullName": "epidermal growth factor receptor", + "uniprotAccessionNumber": "P00533" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 240, + "assayComponentEndpointName": "BSK_hDFCGF_IL8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_IL8 was analyzed into 1 assay endpoint. This assay endpoint, BSK_hDFCGF_IL8, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL8. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is interleukins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 161, + "assayComponentName": "BSK_hDFCGF_IL8", + "assayComponentDesc": "BSK_hDFCGF_IL8 is an assay component measured in the BSK_hDFCGF assay. It measures IL-8 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "IL-8 antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 8 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and growth factors [GeneSymbol:CXCL8 | GeneID:3576 | Uniprot_SwissProt_Accession:P10145].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-8 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 177, + "geneName": "chemokine (C-X-C motif) ligand 8", + "description": null, + "geneSymbol": "CXCL8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3576, + "officialSymbol": "CXCL8", + "officialFullName": "chemokine (C-X-C motif) ligand 8", + "uniprotAccessionNumber": "P10145" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 934, + "assayComponentEndpointName": "LTEA_HepaRG_ALPP", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_ALPP was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_ALPP, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is Cell proliferation, survival, death.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "Cell proliferation, survival, death", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 608, + "assayComponentName": "LTEA_HepaRG_ALPP", + "assayComponentDesc": "LTEA_HepaRG_ALPP is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 24, + "geneName": "alkaline phosphatase, placental", + "description": null, + "geneSymbol": "ALPP", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 250, + "officialSymbol": "ALPP", + "officialFullName": "alkaline phosphatase, placental", + "uniprotAccessionNumber": "P05187" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 804, + "assayComponentEndpointName": "TOX21_TR_LUC_GH3_Antagonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_TR_LUC_GH3_Antagonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_TR_LUC_GH3_Antagonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, loss-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene THRA and THRB. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the nuclear receptor intended target family, where the subfamily is non-steroidal.", + "assayFunctionType": "antagonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "1 nM T3", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "nuclear receptor", + "intendedTargetFamilySub": "non-steroidal", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 541, + "assayComponentName": "TOX21_TR_LUC_GH3_Antagonist", + "assayComponentDesc": "TOX21_TR_LUC_GH3_Antagonist is one of one assay component(s) measured or calculated from the TOX21_TR_LUC_GH3_Antagonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CellTiter-Glo Luciferase-coupled ATP quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction involving the key substrate [One-Glo] are indicative of changes in transcriptional gene expression due to antagonist activity regulated by the human thyroid hormone receptor, alpha and thyroid hormone receptor, beta [GeneSymbol:THRA & THRB | GeneID:7067 & 7068 | Uniprot_SwissProt_Accession:P10827 & P10828]. Thyroid receptor (TR), a nuclear hormone receptor, plays an important role in development, proliferation, differentiation, metabolism, brain function, and cardiovascular system. TR-interacting compounds have been shown to disrupt thyroid homeostasis.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 327, + "assayName": "TOX21_TR_LUC_GH3_Antagonist", + "assayDesc": "TOX21_TR_LUC_GH3_Antagonist is a cell-based, single-readout assay that uses GH3, a rat pituitary gland cell line, with measurements taken at 28 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 28.0, + "organismId": 10116, + "organism": "rat", + "tissue": "pituitary gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "GH3", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 321, + "geneName": "thyroid hormone receptor, alpha", + "description": null, + "geneSymbol": "THRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7067, + "officialSymbol": "THRA", + "officialFullName": "thyroid hormone receptor, alpha", + "uniprotAccessionNumber": "P10827" + }, + "assayList": { + "name": "EDSP thyroid", + "description": "Thyroid pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.2174/2213988501408010036", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24772387", + "pmid": 24772387, + "title": "Identification of thyroid hormone receptor active compounds using a quantitative high-throughput screening platform", + "author": "Freitas J, Miller N, Mengeling BJ, Xia M, Huang R, Houck K, Rietjens IM, Furlow JD, Murk AJ", + "citation": "Freitas J, Miller N, Mengeling BJ, Xia M, Huang R, Houck K, Rietjens IM, Furlow JD, Murk AJ. Identification of thyroid hormone receptor active compounds using a quantitative high-throughput screening platform. Curr Chem Genomics Transl Med. 2014 Mar 7;8:36-46. doi: 10.2174/2213988501408010036. eCollection 2014. PubMed PMID: 24772387; PubMed Central PMCID: PMC3999704.", + "otherId": "0", + "citationId": 223, + "otherSource": "" + } + }, + { + "aeid": 805, + "assayComponentEndpointName": "TOX21_TR_LUC_GH3_Antagonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_TR_LUC_GH3_Antagonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 542, + "assayComponentName": "TOX21_TR_LUC_GH3_Antagonist_viability", + "assayComponentDesc": "TOX21_TR_LUC_GH3_Antagonist_viability is an assay readout measuring viability via receptor activity and designed using bioluminescence signals detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 327, + "assayName": "TOX21_TR_LUC_GH3_Antagonist", + "assayDesc": "TOX21_TR_LUC_GH3_Antagonist is a cell-based, single-readout assay that uses GH3, a rat pituitary gland cell line, with measurements taken at 28 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 28.0, + "organismId": 10116, + "organism": "rat", + "tissue": "pituitary gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "GH3", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.2174/2213988501408010036", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/24772387", + "pmid": 24772387, + "title": "Identification of thyroid hormone receptor active compounds using a quantitative high-throughput screening platform", + "author": "Freitas J, Miller N, Mengeling BJ, Xia M, Huang R, Houck K, Rietjens IM, Furlow JD, Murk AJ", + "citation": "Freitas J, Miller N, Mengeling BJ, Xia M, Huang R, Houck K, Rietjens IM, Furlow JD, Murk AJ. Identification of thyroid hormone receptor active compounds using a quantitative high-throughput screening platform. Curr Chem Genomics Transl Med. 2014 Mar 7;8:36-46. doi: 10.2174/2213988501408010036. eCollection 2014. PubMed PMID: 24772387; PubMed Central PMCID: PMC3999704.", + "otherId": "0", + "citationId": 223, + "otherSource": "" + } + }, + { + "aeid": 806, + "assayComponentEndpointName": "TOX21_AhR_LUC_Agonist", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component TOX21_AhR_LUC_Agonist was analyzed into 1 assay endpoint. This assay endpoint, TOX21_AhR_LUC_Agonist, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain-of-signal activity can be used to understand changes in the reporter gene as they relate to the gene AHR. Furthermore, this assay endpoint can be referred to as a primary readout, because the performed assay has only produced 1 assay endpoint. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the DNA binding intended target family, where the subfamily is basic helix-loop-helix protein.", + "assayFunctionType": "agonist", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Omeprazole", + "signalDirection": "gain", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic helix-loop-helix protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 543, + "assayComponentName": "TOX21_AhR_LUC_Agonist", + "assayComponentDesc": "TOX21_AhR_LUC_Agonist is one of one assay component(s) measured or calculated from the TOX21_AhR_LUC_Agonist assay. It is designed to make measurements of luciferase induction, a form of inducible reporter, as detected with bioluminescence signals by CALUX luciferase quantitation technology.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from the luciferase induction are indicative of agonist activity regulated by the receptor function and kinetics for the human aryl hydrocarbon receptor [GeneSymbol:AHR | GeneID:196 | Uniprot_SwissProt_Accession:P35869].", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "luciferase induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CALUX luciferase quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "One-Glo", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 328, + "assayName": "TOX21_AhR_LUC_Agonist", + "assayDesc": "TOX21_AhR_LUC_Agonist is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": { + "geneId": 21, + "geneName": "aryl hydrocarbon receptor", + "description": null, + "geneSymbol": "AHR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 196, + "officialSymbol": "AHR", + "officialFullName": "aryl hydrocarbon receptor", + "uniprotAccessionNumber": "P35869" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1093/toxsci/kfr189", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21775728", + "pmid": 21775728, + "title": "Third-generation Ah receptor-responsive luciferase reporter plasmids: amplification of dioxin-responsive elements dramatically increases CALUX bioassay sensitivity and responsiveness", + "author": "He G, Tsutsumi T, Zhao B, Baston DS, Zhao J, Heath-Pagliuso S, Denison MS", + "citation": "He G, Tsutsumi T, Zhao B, Baston DS, Zhao J, Heath-Pagliuso S, Denison MS. Third-generation Ah receptor-responsive luciferase reporter plasmids: amplification of dioxin-responsive elements dramatically increases CALUX bioassay sensitivity and responsiveness. Toxicol Sci. 2011 Oct;123(2):511-22. doi: 10.1093/toxsci/kfr189. Epub 2011 Jul 20. PubMed PMID: 21775728; PubMed Central PMCID: PMC3179681.", + "otherId": "0", + "citationId": 227, + "otherSource": "" + } + }, + { + "aeid": 807, + "assayComponentEndpointName": "TOX21_AhR_LUC_Agonist_viability", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "TOX21_AhR_LUC_Agonist_viability used a type of viability reporter where loss-of-signal activity can be used to understand changes in the cell viability. Furthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "percent_activity", + "burstAssay": 1, + "keyPositiveControl": "tetraoctylammonium bromide", + "signalDirection": "loss", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 544, + "assayComponentName": "TOX21_AhR_LUC_Agonist_viability", + "assayComponentDesc": "TOX21_AhR_LUC_Agonist_viability is an assay readout measuring cellular ATP content and detected with CellTiter-Glo Luciferase-coupled ATP quantitation.", + "assayComponentTargetDesc": "Changes to bioluminescence signals produced from an enzymatic reaction catalyzed by luciferase between the key substrate [CellTiter-Glo] and the target cofactor [ATP] are correlated to the viability of the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "ATP content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Luminescence", + "detectionTechnologyTypeSub": "Bioluminescence", + "detectionTechnology": "CellTiter-Glo Luciferase-coupled ATP quantitation", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "CellTiter-Glo", + "technologicalTargetType": "chemical", + "technologicalTargetTypeSub": "ATP", + "aid": 328, + "assayName": "TOX21_AhR_LUC_Agonist", + "assayDesc": "TOX21_AhR_LUC_Agonist is a cell-based, single-readout assay that uses HepG2, a human liver cell line, with measurements taken at 24 hours after chemical dosing in a 1536-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "NA", + "cellShortName": "HepG2", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 1536-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 7, + "assaySourceName": "TOX21", + "assaySourceLongName": "Tox21/NCGC", + "assaySourceDesc": "Tox21 is an interagency agreement between the NIH, NTP, FDA and EPA. NIH Chemical Genomics Center (NCGC) is the primary screening facility running ultra high-throughput screening assays across a large interagency-developed chemical library.", + "gene": null, + "assayList": { + "name": "cytotoxicity burst", + "description": "Assays used to defne the cytotoxicity burst region" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfr189", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/21775728", + "pmid": 21775728, + "title": "Third-generation Ah receptor-responsive luciferase reporter plasmids: amplification of dioxin-responsive elements dramatically increases CALUX bioassay sensitivity and responsiveness", + "author": "He G, Tsutsumi T, Zhao B, Baston DS, Zhao J, Heath-Pagliuso S, Denison MS", + "citation": "He G, Tsutsumi T, Zhao B, Baston DS, Zhao J, Heath-Pagliuso S, Denison MS. Third-generation Ah receptor-responsive luciferase reporter plasmids: amplification of dioxin-responsive elements dramatically increases CALUX bioassay sensitivity and responsiveness. Toxicol Sci. 2011 Oct;123(2):511-22. doi: 10.1093/toxsci/kfr189. Epub 2011 Jul 20. PubMed PMID: 21775728; PubMed Central PMCID: PMC3179681.", + "otherId": "0", + "citationId": 227, + "otherSource": "" + } + }, + { + "aeid": 891, + "assayComponentEndpointName": "CEETOX_H295R_11DCORT", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_11DCORT was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_11DCORT, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of 11-Deoxycortisol in H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is glucocorticoids.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Prochloraz;Forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "11-Deoxycortisol", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "glucocorticoids", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 586, + "assayComponentName": "CEETOX_H295R_11DCORT", + "assayComponentDesc": "CEETOX_H295R_11DCORT is one of 23 assay component(s) measured or calculated from the CEETOX_H295R assay. It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "inducer", + "keyAssayReagent": null, + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "11-Deoxycortisol", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 893, + "assayComponentEndpointName": "CEETOX_H295R_OHPREG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_OHPREG was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_OHPREG, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of 17alpha-hydroxypregnenolone in H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is progestagens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Prochloraz;Forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "17alpha-hydroxypregnenolone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "progestagens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 587, + "assayComponentName": "CEETOX_H295R_OHPREG", + "assayComponentDesc": "CEETOX_H295R_OHPREG is one of 23 assay component(s) measured or calculated from the CEETOX_H295R assay. It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "inducer", + "keyAssayReagent": null, + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "17alpha-hydroxypregnenolone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 895, + "assayComponentEndpointName": "CEETOX_H295R_OHPROG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_OHPROG was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_OHPROG, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of 17alpha-hydroxyprogesterone in H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is progestagens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Prochloraz;Forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "17alpha-hydroxyprogesterone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "progestagens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 588, + "assayComponentName": "CEETOX_H295R_OHPROG", + "assayComponentDesc": "CEETOX_H295R_OHPROG is one of 23 assay component(s) measured or calculated from the CEETOX_H295R assay. It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "inducer", + "keyAssayReagent": null, + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "17alpha-hydroxyprogesterone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 897, + "assayComponentEndpointName": "CEETOX_H295R_ANDR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_ANDR was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_ANDR, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Androstenedione in H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is androgens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Prochloraz;Forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Androstenedione", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "androgens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 589, + "assayComponentName": "CEETOX_H295R_ANDR", + "assayComponentDesc": "CEETOX_H295R_ANDR is one of 23 assay component(s) measured or calculated from the CEETOX_H295R assay. It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "inducer", + "keyAssayReagent": null, + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Androstenedione", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 899, + "assayComponentEndpointName": "CEETOX_H295R_CORTIC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_CORTIC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_CORTIC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Corticosterone in H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is glucocorticoids.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Prochloraz;Forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Corticosterone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "glucocorticoids", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 590, + "assayComponentName": "CEETOX_H295R_CORTIC", + "assayComponentDesc": "CEETOX_H295R_CORTIC is one of 23 assay component(s) measured or calculated from the CEETOX_H295R assay. It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "inducer", + "keyAssayReagent": null, + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Corticosterone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 901, + "assayComponentEndpointName": "CEETOX_H295R_CORTISOL", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_CORTISOL was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_CORTISOL, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Cortisol in H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is glucocorticoids.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Prochloraz;Forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Cortisol", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "glucocorticoids", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 591, + "assayComponentName": "CEETOX_H295R_CORTISOL", + "assayComponentDesc": "CEETOX_H295R_CORTISOL is one of 23 assay component(s) measured or calculated from the CEETOX_H295R assay. It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "inducer", + "keyAssayReagent": null, + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Cortisol", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 905, + "assayComponentEndpointName": "CEETOX_H295R_DOC", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_DOC was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_DOC, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of 11-Deoxycorticosterone in H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is glucocorticoids.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Prochloraz;Forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "11-Deoxycorticosterone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "glucocorticoids", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 593, + "assayComponentName": "CEETOX_H295R_DOC", + "assayComponentDesc": "CEETOX_H295R_DOC is one of 23 assay component(s) measured or calculated from the CEETOX_H295R assay. It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "inducer", + "keyAssayReagent": null, + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "11-Deoxycorticosterone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 145, + "geneName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "description": null, + "geneSymbol": "NR3C1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2908, + "officialSymbol": "NR3C1", + "officialFullName": "nuclear receptor subfamily 3, group C, member 1 (glucocorticoid receptor)", + "uniprotAccessionNumber": "P04150" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 907, + "assayComponentEndpointName": "CEETOX_H295R_ESTRADIOL", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_ESTRADIOL was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_ESTRADIOL, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Estradiol in H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is estrogens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Prochloraz;Forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Estradiol", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "estrogens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 594, + "assayComponentName": "CEETOX_H295R_ESTRADIOL", + "assayComponentDesc": "CEETOX_H295R_ESTRADIOL is one of 23 assay component(s) measured or calculated from the CEETOX_H295R assay. It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "inducer", + "keyAssayReagent": null, + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Estradiol", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 909, + "assayComponentEndpointName": "CEETOX_H295R_ESTRONE", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_ESTRONE was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_ESTRONE, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Estrone in H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is estrogens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Prochloraz;Forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Estrone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "estrogens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 595, + "assayComponentName": "CEETOX_H295R_ESTRONE", + "assayComponentDesc": "CEETOX_H295R_ESTRONE is one of 23 assay component(s) measured or calculated from the CEETOX_H295R assay. It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "inducer", + "keyAssayReagent": null, + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Estrone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 117, + "geneName": "estrogen receptor 1", + "description": null, + "geneSymbol": "ESR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2099, + "officialSymbol": "ESR1", + "officialFullName": "estrogen receptor 1", + "uniprotAccessionNumber": "P03372" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 913, + "assayComponentEndpointName": "CEETOX_H295R_PROG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_PROG was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_PROG, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Progesterone in H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is progestagens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Prochloraz;Forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Progesterone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "progestagens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 597, + "assayComponentName": "CEETOX_H295R_PROG", + "assayComponentDesc": "CEETOX_H295R_PROG is one of 23 assay component(s) measured or calculated from the CEETOX_H295R assay. It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "inducer", + "keyAssayReagent": null, + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Progesterone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 235, + "geneName": "progesterone receptor", + "description": null, + "geneSymbol": "PGR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5241, + "officialSymbol": "PGR", + "officialFullName": "progesterone receptor", + "uniprotAccessionNumber": "P06401" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 915, + "assayComponentEndpointName": "CEETOX_H295R_TESTO", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component CEETOX_H295R_TESTO was analyzed into 1 assay endpoint. This assay endpoint, CEETOX_H295R_TESTO, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, gain or loss-of-signal activity using HPLC-MS-MS was used to understand synthesis of Testosterone in H295R cell line at 48hr of chemical exposure. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the steroid hormone intended target family, where the subfamily is androgens.", + "assayFunctionType": "detection of steroid hormone", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "Prochloraz;Forskolin", + "signalDirection": "bidirectional", + "intendedTargetType": "molecular messenger", + "intendedTargetTypeSub": "Testosterone", + "intendedTargetFamily": "steroid hormone", + "intendedTargetFamilySub": "androgens", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 598, + "assayComponentName": "CEETOX_H295R_TESTO", + "assayComponentDesc": "CEETOX_H295R_TESTO is one of 23 assay component(s) measured or calculated from the CEETOX_H295R assay. It is designed to make measurements of hormone induction, a form of inducible reporter, as detected with absorbance signals by HPLC-MS-MS technology.", + "assayComponentTargetDesc": null, + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "hormone induction", + "biologicalProcessTarget": "regulation of steroid hormone biosynthetic process", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "HPLC-MS-MS", + "keyAssayReagentType": "inducer", + "keyAssayReagent": null, + "technologicalTargetType": "molecular messenger", + "technologicalTargetTypeSub": "Testosterone", + "aid": 370, + "assayName": "CEETOX_H295R", + "assayDesc": "CEETOX_H295R is a cell-based, multiplexed-readout assay that uses H295R, a human adrenal gland cell line, with measurements taken at 48 hours after chemical dosing in a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "adrenal gland", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "H295R", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.1, + "asid": 8, + "assaySourceName": "CEETOX", + "assaySourceLongName": "Ceetox/OpAns", + "assaySourceDesc": "Ceetox, a part of Cyprotex, is a Contract Research Organization (CRO) that in coordination with OpAns, an analytical laboratory, provide ADME-tox services.", + "gene": { + "geneId": 27, + "geneName": "androgen receptor", + "description": null, + "geneSymbol": "AR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 367, + "officialSymbol": "AR", + "officialFullName": "androgen receptor", + "uniprotAccessionNumber": "P10275" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "doi: 10.1093/toxsci/kfw002", + "url": "https://pubmed.ncbi.nlm.nih.gov/26781511/", + "pmid": 26781511, + "title": "High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells", + "author": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT", + "citation": "Karmaus AL, Toole CM, Filer DL, Lewis KC, Martin MT. High-Throughput Screening of Chemical Effects on Steroidogenesis Using H295R Human Adrenocortical Carcinoma Cells. Toxicol Sci. 2016 Apr;150(2):323-32. doi: 10.1093/toxsci/kfw002. Epub 2016 Jan 18. PMID: 26781511; PMCID: PMC4809454.", + "otherId": "0", + "citationId": 245, + "otherSource": "" + } + }, + { + "aeid": 916, + "assayComponentEndpointName": "LTEA_HepaRG_ABCB1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_ABCB1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_ABCB1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 599, + "assayComponentName": "LTEA_HepaRG_ABCB1", + "assayComponentDesc": "LTEA_HepaRG_ABCB1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis/NR mediated transport.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 236, + "geneName": "ATP-binding cassette, sub-family B (MDR/TAP), member 1", + "description": null, + "geneSymbol": "ABCB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5243, + "officialSymbol": "ABCB1", + "officialFullName": "ATP-binding cassette, sub-family B (MDR/TAP), member 1", + "uniprotAccessionNumber": "P08183" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 918, + "assayComponentEndpointName": "LTEA_HepaRG_ABCB11", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_ABCB11 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_ABCB11, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 600, + "assayComponentName": "LTEA_HepaRG_ABCB11", + "assayComponentDesc": "LTEA_HepaRG_ABCB11 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis/NR mediated transport.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 345, + "geneName": "ATP-binding cassette, sub-family B (MDR/TAP), member 11", + "description": null, + "geneSymbol": "ABCB11", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8647, + "officialSymbol": "ABCB11", + "officialFullName": "ATP-binding cassette, sub-family B (MDR/TAP), member 11", + "uniprotAccessionNumber": "O95342" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 920, + "assayComponentEndpointName": "LTEA_HepaRG_ABCC2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_ABCC2 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_ABCC2, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 601, + "assayComponentName": "LTEA_HepaRG_ABCC2", + "assayComponentDesc": "LTEA_HepaRG_ABCC2 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis/NR mediated transport.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 69, + "geneName": "ATP-binding cassette, sub-family C (CFTR/MRP), member 2", + "description": null, + "geneSymbol": "ABCC2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1244, + "officialSymbol": "ABCC2", + "officialFullName": "ATP-binding cassette, sub-family C (CFTR/MRP), member 2", + "uniprotAccessionNumber": "Q92887" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 922, + "assayComponentEndpointName": "LTEA_HepaRG_ABCC3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_ABCC3 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_ABCC3, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 602, + "assayComponentName": "LTEA_HepaRG_ABCC3", + "assayComponentDesc": "LTEA_HepaRG_ABCC3 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated transport.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 347, + "geneName": "ATP-binding cassette, sub-family C (CFTR/MRP), member 3", + "description": null, + "geneSymbol": "ABCC3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8714, + "officialSymbol": "ABCC3", + "officialFullName": "ATP-binding cassette, sub-family C (CFTR/MRP), member 3", + "uniprotAccessionNumber": "O15438" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 924, + "assayComponentEndpointName": "LTEA_HepaRG_ABCG2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_ABCG2 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_ABCG2, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is ABC transporter.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "ABC transporter", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 603, + "assayComponentName": "LTEA_HepaRG_ABCG2", + "assayComponentDesc": "LTEA_HepaRG_ABCG2 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis/NR mediated transport.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 354, + "geneName": "ATP-binding cassette, sub-family G (WHITE), member 2 (Junior blood group)", + "description": null, + "geneSymbol": "ABCG2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9429, + "officialSymbol": "ABCG2", + "officialFullName": "ATP-binding cassette, sub-family G (WHITE), member 2 (Junior blood group)", + "uniprotAccessionNumber": "Q9UNQ0" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 926, + "assayComponentEndpointName": "LTEA_HepaRG_ACLY", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_ACLY was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_ACLY, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the lyase intended target family, where the subfamily is steatosis.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "lyase", + "intendedTargetFamilySub": "steatosis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 604, + "assayComponentName": "LTEA_HepaRG_ACLY", + "assayComponentDesc": "LTEA_HepaRG_ACLY is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 3, + "geneName": "ATP citrate lyase", + "description": null, + "geneSymbol": "ACLY", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 47, + "officialSymbol": "ACLY", + "officialFullName": "ATP citrate lyase", + "uniprotAccessionNumber": "P53396" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 928, + "assayComponentEndpointName": "LTEA_HepaRG_ACOX1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_ACOX1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_ACOX1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidase intended target family, where the subfamily is steatosis.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "oxidase", + "intendedTargetFamilySub": "steatosis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 605, + "assayComponentName": "LTEA_HepaRG_ACOX1", + "assayComponentDesc": "LTEA_HepaRG_ACOX1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 4, + "geneName": "acyl-CoA oxidase 1, palmitoyl", + "description": null, + "geneSymbol": "ACOX1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 51, + "officialSymbol": "ACOX1", + "officialFullName": "acyl-CoA oxidase 1, palmitoyl", + "uniprotAccessionNumber": "Q15067" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 930, + "assayComponentEndpointName": "LTEA_HepaRG_ADK", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_ADK was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_ADK, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is steatosis.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "steatosis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 606, + "assayComponentName": "LTEA_HepaRG_ADK", + "assayComponentDesc": "LTEA_HepaRG_ADK is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 9, + "geneName": "adenosine kinase", + "description": null, + "geneSymbol": "ADK", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 132, + "officialSymbol": "ADK", + "officialFullName": "adenosine kinase", + "uniprotAccessionNumber": "P55263" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 932, + "assayComponentEndpointName": "LTEA_HepaRG_AFP", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_AFP was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_AFP, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the background measurement intended target family, where the subfamily is assay control.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "background measurement", + "intendedTargetFamilySub": "assay control", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 607, + "assayComponentName": "LTEA_HepaRG_AFP", + "assayComponentDesc": "LTEA_HepaRG_AFP is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Undifferentiated hepatocyte.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 18, + "geneName": "alpha-fetoprotein", + "description": null, + "geneSymbol": "AFP", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 174, + "officialSymbol": "AFP", + "officialFullName": "alpha-fetoprotein", + "uniprotAccessionNumber": "P02771" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 204, + "assayComponentEndpointName": "BSK_BE3C_uPA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3CA was analyzed into 1 assay endpoint. This assay endpoint, BSK_BE3CA, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene PLAU. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is serine protease.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "serine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 143, + "assayComponentName": "BSK_BE3C_uPA", + "assayComponentDesc": "BSK_BE3CA is an assay component measured in the BSK_BE3C assay. It measures uPA antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "uPA antibody is used to tag and quantify the level of plasminogen activator, urokinase protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:PLAU | GeneID:5328 | Uniprot_SwissProt_Accession:P00749].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "uPA antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 240, + "geneName": "plasminogen activator, urokinase", + "description": null, + "geneSymbol": "PLAU", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5328, + "officialSymbol": "PLAU", + "officialFullName": "plasminogen activator, urokinase", + "uniprotAccessionNumber": "P00749" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 206, + "assayComponentEndpointName": "BSK_BE3C_uPAR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_BE3CAR was analyzed into 1 assay endpoint. This assay endpoint, BSK_BE3CAR, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene PLAUR. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is plasmogen activator.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "plasmogen activator", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 144, + "assayComponentName": "BSK_BE3C_uPAR", + "assayComponentDesc": "BSK_BE3CAR is an assay component measured in the BSK_BE3C assay. It measures uPAR antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "uPAR antibody is used to tag and quantify the level of plasminogen activator, urokinase receptor protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:PLAUR | GeneID:5329 | Uniprot_SwissProt_Accession:Q03405].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "uPAR antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 9, + "assayName": "BSK_BE3C", + "assayDesc": "BSK_BE3C is a cell-based, multiplexed-readout assay that uses bronchial epithelial cell, a human lung primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "lung", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "bronchial epithelial cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 241, + "geneName": "plasminogen activator, urokinase receptor", + "description": null, + "geneSymbol": "PLAUR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5329, + "officialSymbol": "PLAUR", + "officialFullName": "plasminogen activator, urokinase receptor", + "uniprotAccessionNumber": "Q03405" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 208, + "assayComponentEndpointName": "BSK_CASM3C_HLADR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_HLADR was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3C_HLADR, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene HLA-DRA. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is MHC Class II.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "MHC Class II", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 145, + "assayComponentName": "BSK_CASM3C_HLADR", + "assayComponentDesc": "BSK_CASM3C_HLADR is an assay component measured in the BSK_CASM3C assay. It measures HLA-DR antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "HLA-DR antibody is used to tag and quantify the level of major histocompatibility complex, class II, DR alpha protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:HLA-DRA | GeneID:3122 | Uniprot_SwissProt_Accession:P01903].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "HLA-DR antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 153, + "geneName": "major histocompatibility complex, class II, DR alpha", + "description": null, + "geneSymbol": "HLA-DRA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3122, + "officialSymbol": "HLA-DRA", + "officialFullName": "major histocompatibility complex, class II, DR alpha", + "uniprotAccessionNumber": "P01903" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 210, + "assayComponentEndpointName": "BSK_CASM3C_IL6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_CASM3C_IL6 was analyzed into 1 assay endpoint. This assay endpoint, BSK_CASM3C_IL6, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene IL6. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is interleukins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 146, + "assayComponentName": "BSK_CASM3C_IL6", + "assayComponentDesc": "BSK_CASM3C_IL6 is an assay component measured in the BSK_CASM3C assay. It measures IL-6 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "IL-6 antibody is used to tag and quantify the level of interleukin 6 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines [GeneSymbol:IL6 | GeneID:3569 | Uniprot_SwissProt_Accession:P05231].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-6 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 10, + "assayName": "BSK_CASM3C", + "assayDesc": "BSK_CASM3C is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and coronary artery smooth muscle cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "coronary artery smooth muscle cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 175, + "geneName": "interleukin 6", + "description": null, + "geneSymbol": "IL6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3569, + "officialSymbol": "IL6", + "officialFullName": "interleukin 6", + "uniprotAccessionNumber": "P05231" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 936, + "assayComponentEndpointName": "LTEA_HepaRG_APOA5", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_APOA5 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_APOA5, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the apolipoprotein intended target family, where the subfamily is Steatosis.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "apolipoprotein", + "intendedTargetFamilySub": "Steatosis", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 609, + "assayComponentName": "LTEA_HepaRG_APOA5", + "assayComponentDesc": "LTEA_HepaRG_APOA5 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 443, + "geneName": "apolipoprotein A-V", + "description": null, + "geneSymbol": "APOA5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 116519, + "officialSymbol": "APOA5", + "officialFullName": "apolipoprotein A-V", + "uniprotAccessionNumber": "Q6Q788" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 938, + "assayComponentEndpointName": "LTEA_HepaRG_BAD", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_BAD was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_BAD, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is Cell proliferation, survival, death.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "Cell proliferation, survival, death", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 610, + "assayComponentName": "LTEA_HepaRG_BAD", + "assayComponentDesc": "LTEA_HepaRG_BAD is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 30, + "geneName": "BCL2-associated agonist of cell death", + "description": null, + "geneSymbol": "BAD", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 572, + "officialSymbol": "BAD", + "officialFullName": "BCL2-associated agonist of cell death", + "uniprotAccessionNumber": "Q92934" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 940, + "assayComponentEndpointName": "LTEA_HepaRG_BAX", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_BAX was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_BAX, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is Cell proliferation, survival, death.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "Cell proliferation, survival, death", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 611, + "assayComponentName": "LTEA_HepaRG_BAX", + "assayComponentDesc": "LTEA_HepaRG_BAX is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 31, + "geneName": "BCL2-associated X protein", + "description": null, + "geneSymbol": "BAX", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 581, + "officialSymbol": "BAX", + "officialFullName": "BCL2-associated X protein", + "uniprotAccessionNumber": "Q07812" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 942, + "assayComponentEndpointName": "LTEA_HepaRG_BCL2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_BCL2 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_BCL2, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is Cell proliferation, survival, death.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "Cell proliferation, survival, death", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 612, + "assayComponentName": "LTEA_HepaRG_BCL2", + "assayComponentDesc": "LTEA_HepaRG_BCL2 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 34, + "geneName": "B-cell CLL/lymphoma 2", + "description": null, + "geneSymbol": "BCL2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 596, + "officialSymbol": "BCL2", + "officialFullName": "B-cell CLL/lymphoma 2", + "uniprotAccessionNumber": "P10415" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 944, + "assayComponentEndpointName": "LTEA_HepaRG_BCL2L11", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_BCL2L11 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_BCL2L11, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is Cell proliferation, survival, death.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "Cell proliferation, survival, death", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 613, + "assayComponentName": "LTEA_HepaRG_BCL2L11", + "assayComponentDesc": "LTEA_HepaRG_BCL2L11 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 362, + "geneName": "BCL2-like 11 (apoptosis facilitator)", + "description": null, + "geneSymbol": "BCL2L11", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10018, + "officialSymbol": "BCL2L11", + "officialFullName": "BCL2-like 11 (apoptosis facilitator)", + "uniprotAccessionNumber": "O43521" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 946, + "assayComponentEndpointName": "LTEA_HepaRG_BID", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_BID was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_BID, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is Cell proliferation, survival, death.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "Cell proliferation, survival, death", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 614, + "assayComponentName": "LTEA_HepaRG_BID", + "assayComponentDesc": "LTEA_HepaRG_BID is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 35, + "geneName": "BH3 interacting domain death agonist", + "description": null, + "geneSymbol": "BID", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 637, + "officialSymbol": "BID", + "officialFullName": "BH3 interacting domain death agonist", + "uniprotAccessionNumber": "P55957" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 948, + "assayComponentEndpointName": "LTEA_HepaRG_CASP3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CASP3 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CASP3, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is cysteine protease.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "cysteine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 615, + "assayComponentName": "LTEA_HepaRG_CASP3", + "assayComponentDesc": "LTEA_HepaRG_CASP3 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 41, + "geneName": "caspase 3, apoptosis-related cysteine peptidase", + "description": null, + "geneSymbol": "CASP3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 836, + "officialSymbol": "CASP3", + "officialFullName": "caspase 3, apoptosis-related cysteine peptidase", + "uniprotAccessionNumber": "P42574" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 950, + "assayComponentEndpointName": "LTEA_HepaRG_CASP8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CASP8 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CASP8, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is cysteine protease.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "cysteine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 616, + "assayComponentName": "LTEA_HepaRG_CASP8", + "assayComponentDesc": "LTEA_HepaRG_CASP8 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 44, + "geneName": "caspase 8, apoptosis-related cysteine peptidase", + "description": null, + "geneSymbol": "CASP8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 841, + "officialSymbol": "CASP8", + "officialFullName": "caspase 8, apoptosis-related cysteine peptidase", + "uniprotAccessionNumber": "Q14790" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 952, + "assayComponentEndpointName": "LTEA_HepaRG_CAT", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CAT was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CAT, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the catalase intended target family, where the subfamily is oxidative stress.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "catalase", + "intendedTargetFamilySub": "oxidative stress", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 617, + "assayComponentName": "LTEA_HepaRG_CAT", + "assayComponentDesc": "LTEA_HepaRG_CAT is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Oxidative Stress.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 46, + "geneName": "catalase", + "description": null, + "geneSymbol": "CAT", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 847, + "officialSymbol": "CAT", + "officialFullName": "catalase", + "uniprotAccessionNumber": "P04040" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 954, + "assayComponentEndpointName": "LTEA_HepaRG_CCND1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CCND1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CCND1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is Cell proliferation, survival, death.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "Cell proliferation, survival, death", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 618, + "assayComponentName": "LTEA_HepaRG_CCND1", + "assayComponentDesc": "LTEA_HepaRG_CCND1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 33, + "geneName": "cyclin D1", + "description": null, + "geneSymbol": "CCND1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 595, + "officialSymbol": "CCND1", + "officialFullName": "cyclin D1", + "uniprotAccessionNumber": "P24385" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 956, + "assayComponentEndpointName": "LTEA_HepaRG_CCND2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CCND2 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CCND2, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is Cell proliferation, survival, death.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "Cell proliferation, survival, death", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 619, + "assayComponentName": "LTEA_HepaRG_CCND2", + "assayComponentDesc": "LTEA_HepaRG_CCND2 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 47, + "geneName": "cyclin D2", + "description": null, + "geneSymbol": "CCND2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 894, + "officialSymbol": "CCND2", + "officialFullName": "cyclin D2", + "uniprotAccessionNumber": "P30279" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 958, + "assayComponentEndpointName": "LTEA_HepaRG_CDKN1A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CDKN1A was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CDKN1A, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is Cell proliferation, survival, death.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "Cell proliferation, survival, death", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 620, + "assayComponentName": "LTEA_HepaRG_CDKN1A", + "assayComponentDesc": "LTEA_HepaRG_CDKN1A is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 57, + "geneName": "cyclin-dependent kinase inhibitor 1A (p21, Cip1)", + "description": null, + "geneSymbol": "CDKN1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1026, + "officialSymbol": "CDKN1A", + "officialFullName": "cyclin-dependent kinase inhibitor 1A (p21, Cip1)", + "uniprotAccessionNumber": "P38936" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 960, + "assayComponentEndpointName": "LTEA_HepaRG_CFLAR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CFLAR was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CFLAR, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is Cell proliferation, survival, death.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "Cell proliferation, survival, death", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 621, + "assayComponentName": "LTEA_HepaRG_CFLAR", + "assayComponentDesc": "LTEA_HepaRG_CFLAR is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 348, + "geneName": "CASP8 and FADD-like apoptosis regulator", + "description": null, + "geneSymbol": "CFLAR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8837, + "officialSymbol": "CFLAR", + "officialFullName": "CASP8 and FADD-like apoptosis regulator", + "uniprotAccessionNumber": "O15519" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 962, + "assayComponentEndpointName": "LTEA_HepaRG_CYP1A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP1A1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP1A1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 622, + "assayComponentName": "LTEA_HepaRG_CYP1A1", + "assayComponentDesc": "LTEA_HepaRG_CYP1A1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 77, + "geneName": "cytochrome P450, family 1, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP1A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1543, + "officialSymbol": "CYP1A1", + "officialFullName": "cytochrome P450, family 1, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "P04798" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 964, + "assayComponentEndpointName": "LTEA_HepaRG_CYP1A2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP1A2 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP1A2, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 623, + "assayComponentName": "LTEA_HepaRG_CYP1A2", + "assayComponentDesc": "LTEA_HepaRG_CYP1A2 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 78, + "geneName": "cytochrome P450, family 1, subfamily A, polypeptide 2", + "description": null, + "geneSymbol": "CYP1A2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1544, + "officialSymbol": "CYP1A2", + "officialFullName": "cytochrome P450, family 1, subfamily A, polypeptide 2", + "uniprotAccessionNumber": "P05177" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 966, + "assayComponentEndpointName": "LTEA_HepaRG_CYP24A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP24A1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP24A1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 624, + "assayComponentName": "LTEA_HepaRG_CYP24A1", + "assayComponentDesc": "LTEA_HepaRG_CYP24A1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 95, + "geneName": "cytochrome P450, family 24, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP24A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1591, + "officialSymbol": "CYP24A1", + "officialFullName": "cytochrome P450, family 24, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "Q07973" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 968, + "assayComponentEndpointName": "LTEA_HepaRG_CYP2B6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP2B6 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP2B6, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 625, + "assayComponentName": "LTEA_HepaRG_CYP2B6", + "assayComponentDesc": "LTEA_HepaRG_CYP2B6 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 82, + "geneName": "cytochrome P450, family 2, subfamily B, polypeptide 6", + "description": null, + "geneSymbol": "CYP2B6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1555, + "officialSymbol": "CYP2B6", + "officialFullName": "cytochrome P450, family 2, subfamily B, polypeptide 6", + "uniprotAccessionNumber": "P20813" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 970, + "assayComponentEndpointName": "LTEA_HepaRG_CYP2C19", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP2C19 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP2C19, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 626, + "assayComponentName": "LTEA_HepaRG_CYP2C19", + "assayComponentDesc": "LTEA_HepaRG_CYP2C19 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 83, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "description": null, + "geneSymbol": "CYP2C19", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1557, + "officialSymbol": "CYP2C19", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "uniprotAccessionNumber": "P33261" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 972, + "assayComponentEndpointName": "LTEA_HepaRG_CYP2C8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP2C8 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP2C8, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 627, + "assayComponentName": "LTEA_HepaRG_CYP2C8", + "assayComponentDesc": "LTEA_HepaRG_CYP2C8 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 84, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 8", + "description": null, + "geneSymbol": "CYP2C8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1558, + "officialSymbol": "CYP2C8", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 8", + "uniprotAccessionNumber": "P10632" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 974, + "assayComponentEndpointName": "LTEA_HepaRG_CYP2C9", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP2C9 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP2C9, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 628, + "assayComponentName": "LTEA_HepaRG_CYP2C9", + "assayComponentDesc": "LTEA_HepaRG_CYP2C9 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 85, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 9", + "description": null, + "geneSymbol": "CYP2C9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1559, + "officialSymbol": "CYP2C9", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 9", + "uniprotAccessionNumber": "P11712" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 976, + "assayComponentEndpointName": "LTEA_HepaRG_CYP2E1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP2E1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP2E1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 629, + "assayComponentName": "LTEA_HepaRG_CYP2E1", + "assayComponentDesc": "LTEA_HepaRG_CYP2E1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 88, + "geneName": "cytochrome P450, family 2, subfamily E, polypeptide 1", + "description": null, + "geneSymbol": "CYP2E1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1571, + "officialSymbol": "CYP2E1", + "officialFullName": "cytochrome P450, family 2, subfamily E, polypeptide 1", + "uniprotAccessionNumber": "P05181" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 978, + "assayComponentEndpointName": "LTEA_HepaRG_CYP3A4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP3A4 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP3A4, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 630, + "assayComponentName": "LTEA_HepaRG_CYP3A4", + "assayComponentDesc": "LTEA_HepaRG_CYP3A4 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 90, + "geneName": "cytochrome P450, family 3, subfamily A, polypeptide 4", + "description": null, + "geneSymbol": "CYP3A4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1576, + "officialSymbol": "CYP3A4", + "officialFullName": "cytochrome P450, family 3, subfamily A, polypeptide 4", + "uniprotAccessionNumber": "P08684" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 980, + "assayComponentEndpointName": "LTEA_HepaRG_CYP3A5", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP3A5 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP3A5, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 631, + "assayComponentName": "LTEA_HepaRG_CYP3A5", + "assayComponentDesc": "LTEA_HepaRG_CYP3A5 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 91, + "geneName": "cytochrome P450, family 3, subfamily A, polypeptide 5", + "description": null, + "geneSymbol": "CYP3A5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1577, + "officialSymbol": "CYP3A5", + "officialFullName": "cytochrome P450, family 3, subfamily A, polypeptide 5", + "uniprotAccessionNumber": "P20815" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 982, + "assayComponentEndpointName": "LTEA_HepaRG_CYP3A7", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP3A7 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP3A7, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 632, + "assayComponentName": "LTEA_HepaRG_CYP3A7", + "assayComponentDesc": "LTEA_HepaRG_CYP3A7 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism/Undifferentiated hepatocyte.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 81, + "geneName": "cytochrome P450, family 3, subfamily A, polypeptide 7", + "description": null, + "geneSymbol": "CYP3A7", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1551, + "officialSymbol": "CYP3A7", + "officialFullName": "cytochrome P450, family 3, subfamily A, polypeptide 7", + "uniprotAccessionNumber": "P24462" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 984, + "assayComponentEndpointName": "LTEA_HepaRG_CYP4A11", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP4A11 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP4A11, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 633, + "assayComponentName": "LTEA_HepaRG_CYP4A11", + "assayComponentDesc": "LTEA_HepaRG_CYP4A11 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 92, + "geneName": "cytochrome P450, family 4, subfamily A, polypeptide 11", + "description": null, + "geneSymbol": "CYP4A11", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1579, + "officialSymbol": "CYP4A11", + "officialFullName": "cytochrome P450, family 4, subfamily A, polypeptide 11", + "uniprotAccessionNumber": "Q02928" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 986, + "assayComponentEndpointName": "LTEA_HepaRG_CYP4A22", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP4A22 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP4A22, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 634, + "assayComponentName": "LTEA_HepaRG_CYP4A22", + "assayComponentDesc": "LTEA_HepaRG_CYP4A22 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 452, + "geneName": "cytochrome P450, family 4, subfamily A, polypeptide 22", + "description": null, + "geneSymbol": "CYP4A22", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 284541, + "officialSymbol": "CYP4A22", + "officialFullName": "cytochrome P450, family 4, subfamily A, polypeptide 22", + "uniprotAccessionNumber": "Q5TCH4" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 988, + "assayComponentEndpointName": "LTEA_HepaRG_CYP7A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_CYP7A1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_CYP7A1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 635, + "assayComponentName": "LTEA_HepaRG_CYP7A1", + "assayComponentDesc": "LTEA_HepaRG_CYP7A1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 93, + "geneName": "cytochrome P450, family 7, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP7A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1581, + "officialSymbol": "CYP7A1", + "officialFullName": "cytochrome P450, family 7, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "P22680" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 990, + "assayComponentEndpointName": "LTEA_HepaRG_DDIT3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_DDIT3 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_DDIT3, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is basic leucine zipper.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "basic leucine zipper", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 636, + "assayComponentName": "LTEA_HepaRG_DDIT3", + "assayComponentDesc": "LTEA_HepaRG_DDIT3 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Oxidative Stress.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 97, + "geneName": "DNA-damage-inducible transcript 3", + "description": null, + "geneSymbol": "DDIT3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1649, + "officialSymbol": "DDIT3", + "officialFullName": "DNA-damage-inducible transcript 3", + "uniprotAccessionNumber": "P35638" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 992, + "assayComponentEndpointName": "LTEA_HepaRG_EGF", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_EGF was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_EGF, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the growth factor intended target family, where the subfamily is EGF-like domain.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "growth factor", + "intendedTargetFamilySub": "EGF-like domain", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 637, + "assayComponentName": "LTEA_HepaRG_EGF", + "assayComponentDesc": "LTEA_HepaRG_EGF is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 107, + "geneName": "epidermal growth factor", + "description": null, + "geneSymbol": "EGF", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1950, + "officialSymbol": "EGF", + "officialFullName": "epidermal growth factor", + "uniprotAccessionNumber": "P01133" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 994, + "assayComponentEndpointName": "LTEA_HepaRG_EGR1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_EGR1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_EGR1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is zinc finger.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "zinc finger", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 638, + "assayComponentName": "LTEA_HepaRG_EGR1", + "assayComponentDesc": "LTEA_HepaRG_EGR1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 109, + "geneName": "early growth response 1", + "description": null, + "geneSymbol": "EGR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1958, + "officialSymbol": "EGR1", + "officialFullName": "early growth response 1", + "uniprotAccessionNumber": "P18146" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 996, + "assayComponentEndpointName": "LTEA_HepaRG_EZR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_EZR was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_EZR, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the membrane protein intended target family, where the subfamily is Cellular remodeling.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "membrane protein", + "intendedTargetFamilySub": "Cellular remodeling", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 639, + "assayComponentName": "LTEA_HepaRG_EZR", + "assayComponentDesc": "LTEA_HepaRG_EZR is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cellular remodeling.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 336, + "geneName": "ezrin", + "description": null, + "geneSymbol": "EZR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7430, + "officialSymbol": "EZR", + "officialFullName": "ezrin", + "uniprotAccessionNumber": "P15311" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 998, + "assayComponentEndpointName": "LTEA_HepaRG_FABP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_FABP1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_FABP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the transporter intended target family, where the subfamily is fatty acid carrier protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "transporter", + "intendedTargetFamilySub": "fatty acid carrier protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 640, + "assayComponentName": "LTEA_HepaRG_FABP1", + "assayComponentDesc": "LTEA_HepaRG_FABP1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 124, + "geneName": "fatty acid binding protein 1, liver", + "description": null, + "geneSymbol": "FABP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2168, + "officialSymbol": "FABP1", + "officialFullName": "fatty acid binding protein 1, liver", + "uniprotAccessionNumber": "P07148" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1000, + "assayComponentEndpointName": "LTEA_HepaRG_FAS", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_FAS was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_FAS, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine receptor intended target family, where the subfamily is TNF receptor.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cytokine receptor", + "intendedTargetFamilySub": "TNF receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 641, + "assayComponentName": "LTEA_HepaRG_FAS", + "assayComponentDesc": "LTEA_HepaRG_FAS is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 26, + "geneName": "Fas cell surface death receptor", + "description": null, + "geneSymbol": "FAS", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 355, + "officialSymbol": "FAS", + "officialFullName": "Fas cell surface death receptor", + "uniprotAccessionNumber": "P25445" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1002, + "assayComponentEndpointName": "LTEA_HepaRG_FASN", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_FASN was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_FASN, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the lyase intended target family, where the subfamily is fatty acid synthase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "lyase", + "intendedTargetFamilySub": "fatty acid synthase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 642, + "assayComponentName": "LTEA_HepaRG_FASN", + "assayComponentDesc": "LTEA_HepaRG_FASN is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Steatosis.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 125, + "geneName": "fatty acid synthase", + "description": null, + "geneSymbol": "FASN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2194, + "officialSymbol": "FASN", + "officialFullName": "fatty acid synthase", + "uniprotAccessionNumber": "P49327" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1004, + "assayComponentEndpointName": "LTEA_HepaRG_FMO3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_FMO3 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_FMO3, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the oxidoreductase intended target family, where the subfamily is dioxygenase.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "oxidoreductase", + "intendedTargetFamilySub": "dioxygenase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 643, + "assayComponentName": "LTEA_HepaRG_FMO3", + "assayComponentDesc": "LTEA_HepaRG_FMO3 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of NR mediated metabolism.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 133, + "geneName": "flavin containing monooxygenase 3", + "description": null, + "geneSymbol": "FMO3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2328, + "officialSymbol": "FMO3", + "officialFullName": "flavin containing monooxygenase 3", + "uniprotAccessionNumber": "P31513" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1006, + "assayComponentEndpointName": "LTEA_HepaRG_FOXO1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_FOXO1 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_FOXO1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is forkhead box protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "forkhead box protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 644, + "assayComponentName": "LTEA_HepaRG_FOXO1", + "assayComponentDesc": "LTEA_HepaRG_FOXO1 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 129, + "geneName": "forkhead box O1", + "description": null, + "geneSymbol": "FOXO1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2308, + "officialSymbol": "FOXO1", + "officialFullName": "forkhead box O1", + "uniprotAccessionNumber": "Q12778" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1008, + "assayComponentEndpointName": "LTEA_HepaRG_FOXO3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_FOXO3 was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_FOXO3, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the dna binding intended target family, where the subfamily is forkhead box protein.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "dna binding", + "intendedTargetFamilySub": "forkhead box protein", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 645, + "assayComponentName": "LTEA_HepaRG_FOXO3", + "assayComponentDesc": "LTEA_HepaRG_FOXO3 is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 130, + "geneName": "forkhead box O3", + "description": null, + "geneSymbol": "FOXO3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2309, + "officialSymbol": "FOXO3", + "officialFullName": "forkhead box O3", + "uniprotAccessionNumber": "O43524" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1010, + "assayComponentEndpointName": "LTEA_HepaRG_GADD45A", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_GADD45A was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_GADD45A, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is Oxidative Stress.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "Oxidative Stress", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 646, + "assayComponentName": "LTEA_HepaRG_GADD45A", + "assayComponentDesc": "LTEA_HepaRG_GADD45A is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Oxidative Stress.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 96, + "geneName": "growth arrest and DNA-damage-inducible, alpha", + "description": null, + "geneSymbol": "GADD45A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1647, + "officialSymbol": "GADD45A", + "officialFullName": "growth arrest and DNA-damage-inducible, alpha", + "uniprotAccessionNumber": "P24522" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 1012, + "assayComponentEndpointName": "LTEA_HepaRG_GADD45B", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component LTEA_HepaRG_GADD45B was analyzed into 1 endpoint. This assay endpoint, LTEA_HepaRG_GADD45B, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. Using a type of inducible reporter, measures of mRNA induction for gain or loss-of-signal activity can be used to understand regulation of transcription factor activity. To generalize the intended target to other relatable targets, this assay endpoint is annotated to the mutagenicity response intended target family, where the subfamily is Cell proliferation, survival, death.", + "assayFunctionType": "reporter gene", + "normalizedDataType": "log2_fold_induction", + "burstAssay": 0, + "keyPositiveControl": null, + "signalDirection": "bidirectional", + "intendedTargetType": "rna", + "intendedTargetTypeSub": "mRNA", + "intendedTargetFamily": "mutagenicity response", + "intendedTargetFamilySub": "Cell proliferation, survival, death", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 647, + "assayComponentName": "LTEA_HepaRG_GADD45B", + "assayComponentDesc": "LTEA_HepaRG_GADD45B is one of 102 assay component(s) measured in the LTEA HepaRG cell culture assay. It is a marker of Cell proliferation, survival, death.", + "assayComponentTargetDesc": "Metabolically-competent HepaRG cell cultures were exposed to a chemical for 48 hours before cytotoxicty (LDH) and alterations in transcription were assessed.", + "parameterReadoutType": "single", + "assayDesignType": "inducible reporter", + "assayDesignTypeSub": "mRNA induction", + "biologicalProcessTarget": "regulation of transcription factor activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluidigm qRT-PCR", + "keyAssayReagentType": null, + "keyAssayReagent": null, + "technologicalTargetType": "rna", + "technologicalTargetTypeSub": "mRNA", + "aid": 371, + "assayName": "LTEA_HepaRG", + "assayDesc": "LTEA_HepaRG is a cell based, multiplexed-readout assay that uses HepaRG, a human liver cell line, with measurements taken at 48 hours after chemical dosing on a 96-well plate.", + "timepointHr": 48.0, + "organismId": 9606, + "organism": "human", + "tissue": "liver", + "cellFormat": "cell line", + "cellFreeComponentSource": "", + "cellShortName": "HepaRG", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.5, + "asid": 9, + "assaySourceName": "LTEA", + "assaySourceLongName": "LifeTech/Expression Analysis", + "assaySourceDesc": "Life Technologies, acquired by Thermo Fisher, is a Contract Research Organization (CRO) that provides transcriptomics and expression screening.", + "gene": { + "geneId": 214, + "geneName": "growth arrest and DNA-damage-inducible, beta", + "description": null, + "geneSymbol": "GADD45B", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4616, + "officialSymbol": "GADD45B", + "officialFullName": "growth arrest and DNA-damage-inducible, beta", + "uniprotAccessionNumber": "O75293" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1038/s41540-020-00166-2", + "url": "https://pubmed.ncbi.nlm.nih.gov/33504769/", + "pmid": 33504769, + "title": "High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures", + "author": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF", + "citation": "Franzosa JA, Bonzo JA, Jack J, Baker NC, Kothiya P, Witek RP, Hurban P, Siferd S, Hester S, Shah I, Ferguson SS, Houck KA, Wambaugh JF. High-throughput toxicogenomic screening of chemicals in the environment using metabolically competent hepatic cell cultures. NPJ Syst Biol Appl. 2021 Jan 27;7(1):7. doi: 10.1038/s41540-020-00166-2. PMID: 33504769; PMCID: PMC7840683.", + "otherId": "0", + "citationId": 247, + "otherSource": "" + } + }, + { + "aeid": 242, + "assayComponentEndpointName": "BSK_hDFCGF_IP10", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_IP10 was analyzed into 1 assay endpoint. This assay endpoint, BSK_hDFCGF_IP10, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL10. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 162, + "assayComponentName": "BSK_hDFCGF_IP10", + "assayComponentDesc": "BSK_hDFCGF_IP10 is an assay component measured in the BSK_hDFCGF assay. It measures IP-10 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "IP-10 antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 10 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and growth factors [GeneSymbol:CXCL10 | GeneID:3627 | Uniprot_SwissProt_Accession:P02778].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IP-10 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 178, + "geneName": "chemokine (C-X-C motif) ligand 10", + "description": null, + "geneSymbol": "CXCL10", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3627, + "officialSymbol": "CXCL10", + "officialFullName": "chemokine (C-X-C motif) ligand 10", + "uniprotAccessionNumber": "P02778" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 244, + "assayComponentEndpointName": "BSK_hDFCGF_MCSF", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_MCSF was analyzed into 1 assay endpoint. This assay endpoint, BSK_hDFCGF_MCSF, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CSF1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is colony stimulating factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "colony stimulating factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 163, + "assayComponentName": "BSK_hDFCGF_MCSF", + "assayComponentDesc": "BSK_hDFCGF_MCSF is an assay component measured in the BSK_hDFCGF assay. It measures M-CSF antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "M-CSF antibody is used to tag and quantify the level of colony stimulating factor 1 (macrophage) protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and growth factors [GeneSymbol:CSF1 | GeneID:1435 | Uniprot_SwissProt_Accession:P09603].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "M-CSF antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 72, + "geneName": "colony stimulating factor 1 (macrophage)", + "description": null, + "geneSymbol": "CSF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1435, + "officialSymbol": "CSF1", + "officialFullName": "colony stimulating factor 1 (macrophage)", + "uniprotAccessionNumber": "P09603" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 246, + "assayComponentEndpointName": "BSK_hDFCGF_MIG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_MIG was analyzed into 1 assay endpoint. This assay endpoint, BSK_hDFCGF_MIG, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL9. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 164, + "assayComponentName": "BSK_hDFCGF_MIG", + "assayComponentDesc": "BSK_hDFCGF_MIG is an assay component measured in the BSK_hDFCGF assay. It measures MIG antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MIG antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 9 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and growth factors [GeneSymbol:CXCL9 | GeneID:4283 | Uniprot_SwissProt_Accession:Q07325].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MIG antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 201, + "geneName": "chemokine (C-X-C motif) ligand 9", + "description": null, + "geneSymbol": "CXCL9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4283, + "officialSymbol": "CXCL9", + "officialFullName": "chemokine (C-X-C motif) ligand 9", + "uniprotAccessionNumber": "Q07325" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 248, + "assayComponentEndpointName": "BSK_hDFCGF_MMP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_MMP1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_hDFCGF_MMP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene MMP1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metalloproteinase.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 165, + "assayComponentName": "BSK_hDFCGF_MMP1", + "assayComponentDesc": "BSK_hDFCGF_MMP1 is an assay component measured in the BSK_hDFCGF assay. It measures MMP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MMP-1 antibody is used to tag and quantify the level of matrix metallopeptidase 1 (interstitial collagenase) protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and growth factors [GeneSymbol:MMP1 | GeneID:4312 | Uniprot_SwissProt_Accession:P03956].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MMP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 203, + "geneName": "matrix metallopeptidase 1 (interstitial collagenase)", + "description": null, + "geneSymbol": "MMP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4312, + "officialSymbol": "MMP1", + "officialFullName": "matrix metallopeptidase 1 (interstitial collagenase)", + "uniprotAccessionNumber": "P03956" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 250, + "assayComponentEndpointName": "BSK_hDFCGF_PAI1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_PAI1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_hDFCGF_PAI1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene SERPINE1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is plasmogen activator inhibitor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "plasmogen activator inhibitor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 166, + "assayComponentName": "BSK_hDFCGF_PAI1", + "assayComponentDesc": "BSK_hDFCGF_PAI1 is an assay component measured in the BSK_hDFCGF assay. It measures PAI-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "PAI-1 antibody is used to tag and quantify the level of serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and growth factors [GeneSymbol:SERPINE1 | GeneID:5054 | Uniprot_SwissProt_Accession:P05121].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "PAI-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 229, + "geneName": "serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1", + "description": null, + "geneSymbol": "SERPINE1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5054, + "officialSymbol": "SERPINE1", + "officialFullName": "serpin peptidase inhibitor, clade E (nexin, plasminogen activator inhibitor type 1), member 1", + "uniprotAccessionNumber": "P05121" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 252, + "assayComponentEndpointName": "BSK_hDFCGF_Proliferation", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_Proliferation was analyzed into 1 assay endpoint. \nThis assay endpoint, BSK_hDFCGF_Proliferation, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of total protein for gain or loss-of-signal activity can be used to understand the viability at the cellular-level. \nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is proliferation.", + "assayFunctionType": "viability", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 167, + "assayComponentName": "BSK_hDFCGF_Proliferation", + "assayComponentDesc": "BSK_hDFCGF_Proliferation is an assay component measured in the BSK_hDFCGF assay. It measures 0.1% sulforhodamine related to cell proliferation using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "0.1% sulforhodamine is used to tag and quantify the total protein levels in the system. Changes to these absorbance signals can be indicative of the viability in the system when conditioned to simulate proinflammation from cytokines and growth factors.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 254, + "assayComponentEndpointName": "BSK_hDFCGF_SRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_SRB was analyzed into 1 assay endpoint. This assay endpoint, BSK_hDFCGF_SRB, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is cell conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 168, + "assayComponentName": "BSK_hDFCGF_SRB", + "assayComponentDesc": "BSK_hDFCGF_SRB is an assay component measured in the BSK_hDFCGF assay. It measures 0.1% sulforhodamine related to cell death using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "0.1% sulforhodamine is used to tag and quantify the total protein levels in the system. Changes to these absorbance signals can be indicative of the viability in the system when conditioned to simulate proinflammation from cytokines and growth factors.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 256, + "assayComponentEndpointName": "BSK_hDFCGF_TIMP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_TIMP1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_hDFCGF_TIMP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene TIMP1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease inhibitor intended target family, where the subfamily is metalloproteinase inhibitor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease inhibitor", + "intendedTargetFamilySub": "metalloproteinase inhibitor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 169, + "assayComponentName": "BSK_hDFCGF_TIMP1", + "assayComponentDesc": "BSK_hDFCGF_TIMP1 is an assay component measured in the BSK_hDFCGF assay. It measures TIMP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "TIMP-1 antibody is used to tag and quantify the level of TIMP metallopeptidase inhibitor 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and growth factors [GeneSymbol:TIMP1 | GeneID:7076 | Uniprot_SwissProt_Accession:P01033].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TIMP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 324, + "geneName": "TIMP metallopeptidase inhibitor 1", + "description": null, + "geneSymbol": "TIMP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7076, + "officialSymbol": "TIMP1", + "officialFullName": "TIMP metallopeptidase inhibitor 1", + "uniprotAccessionNumber": "P01033" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 258, + "assayComponentEndpointName": "BSK_hDFCGF_VCAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_hDFCGF_VCAM1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_hDFCGF_VCAM1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene VCAM1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is Immunoglobulin CAM.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 170, + "assayComponentName": "BSK_hDFCGF_VCAM1", + "assayComponentDesc": "BSK_hDFCGF_VCAM1 is an assay component measured in the BSK_hDFCGF assay. It measures VCAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "VCAM-1 antibody is used to tag and quantify the level of vascular cell adhesion molecule 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and growth factors [GeneSymbol:VCAM1 | GeneID:7412 | Uniprot_SwissProt_Accession:P19320].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "VCAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 11, + "assayName": "BSK_hDFCGF", + "assayDesc": "BSK_hDFCGF is a cell-based, multiplexed-readout assay that uses foreskin fibroblast, a human skin primary cell, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell", + "cellFreeComponentSource": "NA", + "cellShortName": "foreskin fibroblast", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 334, + "geneName": "vascular cell adhesion molecule 1", + "description": null, + "geneSymbol": "VCAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7412, + "officialSymbol": "VCAM1", + "officialFullName": "vascular cell adhesion molecule 1", + "uniprotAccessionNumber": "P19320" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 260, + "assayComponentEndpointName": "BSK_KF3CT_ICAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_KF3CT_ICAM1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_KF3CT_ICAM1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene ICAM1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is Immunoglobulin CAM.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 171, + "assayComponentName": "BSK_KF3CT_ICAM1", + "assayComponentDesc": "BSK_KF3CT_ICAM1 is an assay component measured in the BSK_KF3CT assay. It measures ICAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "ICAM-1 antibody is used to tag and quantify the level of intercellular adhesion molecule 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and TGFb [GeneSymbol:ICAM1 | GeneID:3383 | Uniprot_SwissProt_Accession:P05362].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "ICAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 12, + "assayName": "BSK_KF3CT", + "assayDesc": "BSK_KF3CT is a cell-based, multiplexed-readout assay that uses keratinocytes and foreskin fibroblasts, a human skin primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "keratinocytes and foreskin fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 170, + "geneName": "intercellular adhesion molecule 1", + "description": null, + "geneSymbol": "ICAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3383, + "officialSymbol": "ICAM1", + "officialFullName": "intercellular adhesion molecule 1", + "uniprotAccessionNumber": "P05362" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 262, + "assayComponentEndpointName": "BSK_KF3CT_IL1a", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_KF3CT_IL1a was analyzed into 1 assay endpoint. This assay endpoint, BSK_KF3CT_IL1a, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene IL1A. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is interleukins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 172, + "assayComponentName": "BSK_KF3CT_IL1a", + "assayComponentDesc": "BSK_KF3CT_IL1a is an assay component measured in the BSK_KF3CT assay. It measures IL-1a antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "IL-1a antibody is used to tag and quantify the level of interleukin 1, alpha protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and TGFb [GeneSymbol:IL1A | GeneID:3552 | Uniprot_SwissProt_Accession:P01583].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-1a antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 12, + "assayName": "BSK_KF3CT", + "assayDesc": "BSK_KF3CT is a cell-based, multiplexed-readout assay that uses keratinocytes and foreskin fibroblasts, a human skin primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "keratinocytes and foreskin fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 174, + "geneName": "interleukin 1, alpha", + "description": null, + "geneSymbol": "IL1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3552, + "officialSymbol": "IL1A", + "officialFullName": "interleukin 1, alpha", + "uniprotAccessionNumber": "P01583" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 264, + "assayComponentEndpointName": "BSK_KF3CT_IP10", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_KF3CT_IP10 was analyzed into 1 assay endpoint. This assay endpoint, BSK_KF3CT_IP10, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL10. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 173, + "assayComponentName": "BSK_KF3CT_IP10", + "assayComponentDesc": "BSK_KF3CT_IP10 is an assay component measured in the BSK_KF3CT assay. It measures IP-10 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "IP-10 antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 10 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and TGFb [GeneSymbol:CXCL10 | GeneID:3627 | Uniprot_SwissProt_Accession:P02778].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IP-10 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 12, + "assayName": "BSK_KF3CT", + "assayDesc": "BSK_KF3CT is a cell-based, multiplexed-readout assay that uses keratinocytes and foreskin fibroblasts, a human skin primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "keratinocytes and foreskin fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 178, + "geneName": "chemokine (C-X-C motif) ligand 10", + "description": null, + "geneSymbol": "CXCL10", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3627, + "officialSymbol": "CXCL10", + "officialFullName": "chemokine (C-X-C motif) ligand 10", + "uniprotAccessionNumber": "P02778" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 266, + "assayComponentEndpointName": "BSK_KF3CT_MCP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_KF3CT_MCP1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_KF3CT_MCP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CCL2. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 174, + "assayComponentName": "BSK_KF3CT_MCP1", + "assayComponentDesc": "BSK_KF3CT_MCP1 is an assay component measured in the BSK_KF3CT assay. It measures MCP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MCP-1 antibody is used to tag and quantify the level of chemokine (C-C motif) ligand 2 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and TGFb [GeneSymbol:CCL2 | GeneID:6347 | Uniprot_SwissProt_Accession:P13500].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MCP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 12, + "assayName": "BSK_KF3CT", + "assayDesc": "BSK_KF3CT is a cell-based, multiplexed-readout assay that uses keratinocytes and foreskin fibroblasts, a human skin primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "keratinocytes and foreskin fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 291, + "geneName": "chemokine (C-C motif) ligand 2", + "description": null, + "geneSymbol": "CCL2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6347, + "officialSymbol": "CCL2", + "officialFullName": "chemokine (C-C motif) ligand 2", + "uniprotAccessionNumber": "P13500" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 268, + "assayComponentEndpointName": "BSK_KF3CT_MMP9", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_KF3CT_MMP9 was analyzed into 1 assay endpoint. This assay endpoint, BSK_KF3CT_MMP9, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene MMP9. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metalloproteinase.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 175, + "assayComponentName": "BSK_KF3CT_MMP9", + "assayComponentDesc": "BSK_KF3CT_MMP9 is an assay component measured in the BSK_KF3CT assay. It measures MMP-9 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MMP-9 antibody is used to tag and quantify the level of matrix metallopeptidase 9 (gelatinase B, 92kDa gelatinase, 92kDa type IV collagenase) protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and TGFb [GeneSymbol:MMP9 | GeneID:4318 | Uniprot_SwissProt_Accession:P14780].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MMP-9 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 12, + "assayName": "BSK_KF3CT", + "assayDesc": "BSK_KF3CT is a cell-based, multiplexed-readout assay that uses keratinocytes and foreskin fibroblasts, a human skin primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "keratinocytes and foreskin fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 207, + "geneName": "matrix metallopeptidase 9 (gelatinase B, 92kDa gelatinase, 92kDa type IV collagenase)", + "description": null, + "geneSymbol": "MMP9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4318, + "officialSymbol": "MMP9", + "officialFullName": "matrix metallopeptidase 9 (gelatinase B, 92kDa gelatinase, 92kDa type IV collagenase)", + "uniprotAccessionNumber": "P14780" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 270, + "assayComponentEndpointName": "BSK_KF3CT_SRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_KF3CT_SRB was analyzed into 1 assay endpoint. This assay endpoint, BSK_KF3CT_SRB, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is cell conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 176, + "assayComponentName": "BSK_KF3CT_SRB", + "assayComponentDesc": "BSK_KF3CT_SRB is an assay component measured in the BSK_KF3CT assay. It measures 0.1% sulforhodamine related to cell death using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "0.1% sulforhodamine is used to tag and quantify the total protein levels in the system. Changes to these absorbance signals can be indicative of the viability in the system when conditioned to simulate proinflammation from cytokines and TGFb.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 12, + "assayName": "BSK_KF3CT", + "assayDesc": "BSK_KF3CT is a cell-based, multiplexed-readout assay that uses keratinocytes and foreskin fibroblasts, a human skin primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "keratinocytes and foreskin fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 272, + "assayComponentEndpointName": "BSK_KF3CT_TGFb1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_KF3CT_TGFb1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_KF3CT_TGFb1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene TGFB1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the growth factor intended target family, where the subfamily is transforming growth factor beta.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "growth factor", + "intendedTargetFamilySub": "transforming growth factor beta", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 177, + "assayComponentName": "BSK_KF3CT_TGFb1", + "assayComponentDesc": "BSK_KF3CT_TGFb1 is an assay component measured in the BSK_KF3CT assay. It measures TGF-b1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "TGF-b1 antibody is used to tag and quantify the level of transforming growth factor, beta 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and TGFb [GeneSymbol:TGFB1 | GeneID:7040 | Uniprot_SwissProt_Accession:P01137].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TGF-b1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 12, + "assayName": "BSK_KF3CT", + "assayDesc": "BSK_KF3CT is a cell-based, multiplexed-readout assay that uses keratinocytes and foreskin fibroblasts, a human skin primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "keratinocytes and foreskin fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 319, + "geneName": "transforming growth factor, beta 1", + "description": null, + "geneSymbol": "TGFB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7040, + "officialSymbol": "TGFB1", + "officialFullName": "transforming growth factor, beta 1", + "uniprotAccessionNumber": "P01137" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 274, + "assayComponentEndpointName": "BSK_KF3CT_TIMP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_KF3CT_TIMP2 was analyzed into 1 assay endpoint. This assay endpoint, BSK_KF3CT_TIMP2, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene TIMP2. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease inhibitor intended target family, where the subfamily is metalloproteinase inhibitor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease inhibitor", + "intendedTargetFamilySub": "metalloproteinase inhibitor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 178, + "assayComponentName": "BSK_KF3CT_TIMP2", + "assayComponentDesc": "BSK_KF3CT_TIMP2 is an assay component measured in the BSK_KF3CT assay. It measures TIMP-2 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "TIMP-2 antibody is used to tag and quantify the level of TIMP metallopeptidase inhibitor 2 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and TGFb [GeneSymbol:TIMP2 | GeneID:7077 | Uniprot_SwissProt_Accession:Q96MC4].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TIMP-2 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 12, + "assayName": "BSK_KF3CT", + "assayDesc": "BSK_KF3CT is a cell-based, multiplexed-readout assay that uses keratinocytes and foreskin fibroblasts, a human skin primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "keratinocytes and foreskin fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 325, + "geneName": "TIMP metallopeptidase inhibitor 2", + "description": null, + "geneSymbol": "TIMP2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7077, + "officialSymbol": "TIMP2", + "officialFullName": "TIMP metallopeptidase inhibitor 2", + "uniprotAccessionNumber": "Q96MC4" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 276, + "assayComponentEndpointName": "BSK_KF3CT_uPA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_KF3CTA was analyzed into 1 assay endpoint. This assay endpoint, BSK_KF3CTA, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene PLAU. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is serine protease.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "serine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 179, + "assayComponentName": "BSK_KF3CT_uPA", + "assayComponentDesc": "BSK_KF3CTA is an assay component measured in the BSK_KF3CT assay. It measures uPA antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "uPA antibody is used to tag and quantify the level of plasminogen activator, urokinase protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from cytokines and TGFb [GeneSymbol:PLAU | GeneID:5328 | Uniprot_SwissProt_Accession:P00749].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "uPA antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 12, + "assayName": "BSK_KF3CT", + "assayDesc": "BSK_KF3CT is a cell-based, multiplexed-readout assay that uses keratinocytes and foreskin fibroblasts, a human skin primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "skin", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "keratinocytes and foreskin fibroblasts", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 240, + "geneName": "plasminogen activator, urokinase", + "description": null, + "geneSymbol": "PLAU", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5328, + "officialSymbol": "PLAU", + "officialFullName": "plasminogen activator, urokinase", + "uniprotAccessionNumber": "P00749" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 278, + "assayComponentEndpointName": "BSK_LPS_CD40", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_CD40 was analyzed into 1 assay endpoint. This assay endpoint, BSK_LPS_CD40, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CD40. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is inflammatory factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "inflammatory factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 180, + "assayComponentName": "BSK_LPS_CD40", + "assayComponentDesc": "BSK_LPS_CD40 is an assay component measured in the BSK_LPS assay. It measures CD40 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "CD40 antibody is used to tag and quantify the level of CD40 molecule, TNF receptor superfamily member 5 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from Toll-like receptor (TLR4) activator [GeneSymbol:CD40 | GeneID:958 | Uniprot_SwissProt_Accession:P25942].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD40 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 49, + "geneName": "CD40 molecule, TNF receptor superfamily member 5", + "description": null, + "geneSymbol": "CD40", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 958, + "officialSymbol": "CD40", + "officialFullName": "CD40 molecule, TNF receptor superfamily member 5", + "uniprotAccessionNumber": "P25942" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 280, + "assayComponentEndpointName": "BSK_LPS_Eselectin", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_Eselectin was analyzed into 1 assay endpoint. This assay endpoint, BSK_LPS_Eselectin, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene SELE. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is selectins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "selectins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 181, + "assayComponentName": "BSK_LPS_Eselectin", + "assayComponentDesc": "BSK_LPS_Eselectin is an assay component measured in the BSK_LPS assay. It measures E-selectin antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "E-selectin antibody is used to tag and quantify the level of selectin E protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from Toll-like receptor (TLR4) activator [GeneSymbol:SELE | GeneID:6401 | Uniprot_SwissProt_Accession:P16581].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "E-selectin antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 293, + "geneName": "selectin E", + "description": null, + "geneSymbol": "SELE", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6401, + "officialSymbol": "SELE", + "officialFullName": "selectin E", + "uniprotAccessionNumber": "P16581" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 282, + "assayComponentEndpointName": "BSK_LPS_IL1a", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_IL1a was analyzed into 1 assay endpoint. This assay endpoint, BSK_LPS_IL1a, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene IL1A. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is interleukins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 182, + "assayComponentName": "BSK_LPS_IL1a", + "assayComponentDesc": "BSK_LPS_IL1a is an assay component measured in the BSK_LPS assay. It measures IL-a antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "IL-a antibody is used to tag and quantify the level of interleukin 1, alpha protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from Toll-like receptor (TLR4) activator [GeneSymbol:IL1A | GeneID:3552 | Uniprot_SwissProt_Accession:P01583].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-a antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 174, + "geneName": "interleukin 1, alpha", + "description": null, + "geneSymbol": "IL1A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3552, + "officialSymbol": "IL1A", + "officialFullName": "interleukin 1, alpha", + "uniprotAccessionNumber": "P01583" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 284, + "assayComponentEndpointName": "BSK_LPS_IL8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_IL8 was analyzed into 1 assay endpoint. This assay endpoint, BSK_LPS_IL8, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL8. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is interleukins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 183, + "assayComponentName": "BSK_LPS_IL8", + "assayComponentDesc": "BSK_LPS_IL8 is an assay component measured in the BSK_LPS assay. It measures IL-8 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "IL-8 antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 8 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from Toll-like receptor (TLR4) activator [GeneSymbol:CXCL8 | GeneID:3576 | Uniprot_SwissProt_Accession:P10145].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-8 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 177, + "geneName": "chemokine (C-X-C motif) ligand 8", + "description": null, + "geneSymbol": "CXCL8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3576, + "officialSymbol": "CXCL8", + "officialFullName": "chemokine (C-X-C motif) ligand 8", + "uniprotAccessionNumber": "P10145" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 286, + "assayComponentEndpointName": "BSK_LPS_MCP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_MCP1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_LPS_MCP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CCL2. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 184, + "assayComponentName": "BSK_LPS_MCP1", + "assayComponentDesc": "BSK_LPS_MCP1 is an assay component measured in the BSK_LPS assay. It measures MCP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MCP-1 antibody is used to tag and quantify the level of chemokine (C-C motif) ligand 2 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from Toll-like receptor (TLR4) activator [GeneSymbol:CCL2 | GeneID:6347 | Uniprot_SwissProt_Accession:P13500].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MCP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 291, + "geneName": "chemokine (C-C motif) ligand 2", + "description": null, + "geneSymbol": "CCL2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6347, + "officialSymbol": "CCL2", + "officialFullName": "chemokine (C-C motif) ligand 2", + "uniprotAccessionNumber": "P13500" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 288, + "assayComponentEndpointName": "BSK_LPS_MCSF", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_MCSF was analyzed into 1 assay endpoint. This assay endpoint, BSK_LPS_MCSF, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CSF1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is colony stimulating factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "colony stimulating factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 185, + "assayComponentName": "BSK_LPS_MCSF", + "assayComponentDesc": "BSK_LPS_MCSF is an assay component measured in the BSK_LPS assay. It measures M-CSF antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "M-CSF antibody is used to tag and quantify the level of colony stimulating factor 1 (macrophage) protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from Toll-like receptor (TLR4) activator [GeneSymbol:CSF1 | GeneID:1435 | Uniprot_SwissProt_Accession:P09603].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "M-CSF antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 72, + "geneName": "colony stimulating factor 1 (macrophage)", + "description": null, + "geneSymbol": "CSF1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1435, + "officialSymbol": "CSF1", + "officialFullName": "colony stimulating factor 1 (macrophage)", + "uniprotAccessionNumber": "P09603" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 290, + "assayComponentEndpointName": "BSK_LPS_PGE2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_PGE2 was analyzed into 1 assay endpoint. This assay endpoint, BSK_LPS_PGE2, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene PTGER2. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the gpcr intended target family, where the subfamily is rhodopsin-like receptor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "gpcr", + "intendedTargetFamilySub": "rhodopsin-like receptor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 186, + "assayComponentName": "BSK_LPS_PGE2", + "assayComponentDesc": "BSK_LPS_PGE2 is an assay component measured in the BSK_LPS assay. It measures PGE2 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "PGE2 antibody is used to tag and quantify the level of prostaglandin E receptor 2 (subtype EP2), 53kDa protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from Toll-like receptor (TLR4) activator [GeneSymbol:PTGER2 | GeneID:5732 | Uniprot_SwissProt_Accession:P43116].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "PGE2 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 264, + "geneName": "prostaglandin E receptor 2 (subtype EP2), 53kDa", + "description": null, + "geneSymbol": "PTGER2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5732, + "officialSymbol": "PTGER2", + "officialFullName": "prostaglandin E receptor 2 (subtype EP2), 53kDa", + "uniprotAccessionNumber": "P43116" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 292, + "assayComponentEndpointName": "BSK_LPS_SRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_SRB was analyzed into 1 assay endpoint. This assay endpoint, BSK_LPS_SRB, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is cell conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 187, + "assayComponentName": "BSK_LPS_SRB", + "assayComponentDesc": "BSK_LPS_SRB is an assay component measured in the BSK_LPS assay. It measures 0.1% sulforhodamine related to cell death using Sulforhodamine staining technology.", + "assayComponentTargetDesc": "0.1% sulforhodamine is used to tag and quantify the total protein levels in the system. Changes to these absorbance signals can be indicative of the viability in the system when conditioned to simulate proinflammation from Toll-like receptor (TLR4) activator.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 294, + "assayComponentEndpointName": "BSK_LPS_TissueFactor", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_TissueFactor was analyzed into 1 assay endpoint. This assay endpoint, BSK_LPS_TissueFactor, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene F3. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is coagulation factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "coagulation factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 188, + "assayComponentName": "BSK_LPS_TissueFactor", + "assayComponentDesc": "BSK_LPS_TissueFactor is an assay component measured in the BSK_LPS assay. It measures CD142 Tissue Factor antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "CD142 Tissue Factor antibody is used to tag and quantify the level of coagulation factor III (thromboplastin, tissue factor) protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from Toll-like receptor (TLR4) activator [GeneSymbol:F3 | GeneID:2152 | Uniprot_SwissProt_Accession:P13726].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD142 Tissue Factor antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 123, + "geneName": "coagulation factor III (thromboplastin, tissue factor)", + "description": null, + "geneSymbol": "F3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2152, + "officialSymbol": "F3", + "officialFullName": "coagulation factor III (thromboplastin, tissue factor)", + "uniprotAccessionNumber": "P13726" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 296, + "assayComponentEndpointName": "BSK_LPS_TNFa", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_TNFa was analyzed into 1 assay endpoint. This assay endpoint, BSK_LPS_TNFa, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene TNF. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is inflammatory factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "inflammatory factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 189, + "assayComponentName": "BSK_LPS_TNFa", + "assayComponentDesc": "BSK_LPS_TNFa is an assay component measured in the BSK_LPS assay. It measures TNF-a antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "TNF-a antibody is used to tag and quantify the level of tumor necrosis factor protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from Toll-like receptor (TLR4) activator [GeneSymbol:TNF | GeneID:7124 | Uniprot_SwissProt_Accession:P01375].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "TNF-a antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 327, + "geneName": "tumor necrosis factor", + "description": null, + "geneSymbol": "TNF", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7124, + "officialSymbol": "TNF", + "officialFullName": "tumor necrosis factor", + "uniprotAccessionNumber": "P01375" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 298, + "assayComponentEndpointName": "BSK_LPS_VCAM1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_LPS_VCAM1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_LPS_VCAM1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene VCAM1. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is Immunoglobulin CAM.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "Immunoglobulin CAM", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 190, + "assayComponentName": "BSK_LPS_VCAM1", + "assayComponentDesc": "BSK_LPS_VCAM1 is an assay component measured in the BSK_LPS assay. It measures VCAM-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "VCAM-1 antibody is used to tag and quantify the level of vascular cell adhesion molecule 1 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from Toll-like receptor (TLR4) activator [GeneSymbol:VCAM1 | GeneID:7412 | Uniprot_SwissProt_Accession:P19320].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "VCAM-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 13, + "assayName": "BSK_LPS", + "assayDesc": "BSK_LPS is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 334, + "geneName": "vascular cell adhesion molecule 1", + "description": null, + "geneSymbol": "VCAM1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 7412, + "officialSymbol": "VCAM1", + "officialFullName": "vascular cell adhesion molecule 1", + "uniprotAccessionNumber": "P19320" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 300, + "assayComponentEndpointName": "BSK_SAg_CD38", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_SAg_CD38 was analyzed into 1 assay endpoint. This assay endpoint, BSK_SAg_CD38, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CD38. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is other cytokine.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "other cytokine", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 191, + "assayComponentName": "BSK_SAg_CD38", + "assayComponentDesc": "BSK_SAg_CD38 is one of 10 assay component(s) measured or calculated from the BSK_SAg assay. It is designed to make measurements of enzyme-linked immunosorbent assay, a form of binding reporter, as detected with fluorescence intensity signals by Enzyme-linked immunosorbent assay technology.", + "assayComponentTargetDesc": "CD38 antibody is used to tag and quantify the level of CD38 molecule protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from T-cell Receptor (TCR) activation [GeneSymbol:CD38 | GeneID:952 | Uniprot_SwissProt_Accession:P28907].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD38 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 14, + "assayName": "BSK_SAg", + "assayDesc": "BSK_SAg is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 48, + "geneName": "CD38 molecule", + "description": null, + "geneSymbol": "CD38", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 952, + "officialSymbol": "CD38", + "officialFullName": "CD38 molecule", + "uniprotAccessionNumber": "P28907" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 302, + "assayComponentEndpointName": "BSK_SAg_CD40", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_SAg_CD40 was analyzed into 1 assay endpoint. This assay endpoint, BSK_SAg_CD40, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CD40. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is inflammatory factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "inflammatory factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 192, + "assayComponentName": "BSK_SAg_CD40", + "assayComponentDesc": "BSK_SAg_CD40 is one of 10 assay component(s) measured or calculated from the BSK_SAg assay. It is designed to make measurements of enzyme-linked immunosorbent assay, a form of binding reporter, as detected with fluorescence intensity signals by Enzyme-linked immunosorbent assay technology.", + "assayComponentTargetDesc": "CD40 antibody is used to tag and quantify the level of CD40 molecule, TNF receptor superfamily member 5 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from T-cell Receptor (TCR) activation [GeneSymbol:CD40 | GeneID:958 | Uniprot_SwissProt_Accession:P25942].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD40 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 14, + "assayName": "BSK_SAg", + "assayDesc": "BSK_SAg is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 49, + "geneName": "CD40 molecule, TNF receptor superfamily member 5", + "description": null, + "geneSymbol": "CD40", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 958, + "officialSymbol": "CD40", + "officialFullName": "CD40 molecule, TNF receptor superfamily member 5", + "uniprotAccessionNumber": "P25942" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 304, + "assayComponentEndpointName": "BSK_SAg_CD69", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_SAg_CD69 was analyzed into 1 assay endpoint. This assay endpoint, BSK_SAg_CD69, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CD69. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is inflammatory factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "inflammatory factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 193, + "assayComponentName": "BSK_SAg_CD69", + "assayComponentDesc": "BSK_SAg_CD69 is one of 10 assay component(s) measured or calculated from the BSK_SAg assay. It is designed to make measurements of enzyme-linked immunosorbent assay, a form of binding reporter, as detected with fluorescence intensity signals by Enzyme-linked immunosorbent assay technology.", + "assayComponentTargetDesc": "CD69 antibody is used to tag and quantify the level of CD69 molecule protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from T-cell Receptor (TCR) activation [GeneSymbol:CD69 | GeneID:969 | Uniprot_SwissProt_Accession:Q07108].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "CD69 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 14, + "assayName": "BSK_SAg", + "assayDesc": "BSK_SAg is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 50, + "geneName": "CD69 molecule", + "description": null, + "geneSymbol": "CD69", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 969, + "officialSymbol": "CD69", + "officialFullName": "CD69 molecule", + "uniprotAccessionNumber": "Q07108" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 306, + "assayComponentEndpointName": "BSK_SAg_Eselectin", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_SAg_Eselectin was analyzed into 1 assay endpoint. This assay endpoint, BSK_SAg_Eselectin, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene SELE. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell adhesion molecules intended target family, where the subfamily is selectins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cell adhesion molecules", + "intendedTargetFamilySub": "selectins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 194, + "assayComponentName": "BSK_SAg_Eselectin", + "assayComponentDesc": "BSK_SAg_Eselectin is an assay component measured in the BSK_SAg assay. It measures E-selectin antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "E-selectin antibody is used to tag and quantify the level of selectin E protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from T-cell Receptor (TCR) activation [GeneSymbol:SELE | GeneID:6401 | Uniprot_SwissProt_Accession:P16581].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "E-selectin antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 14, + "assayName": "BSK_SAg", + "assayDesc": "BSK_SAg is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 293, + "geneName": "selectin E", + "description": null, + "geneSymbol": "SELE", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6401, + "officialSymbol": "SELE", + "officialFullName": "selectin E", + "uniprotAccessionNumber": "P16581" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 308, + "assayComponentEndpointName": "BSK_SAg_IL8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_SAg_IL8 was analyzed into 1 assay endpoint. This assay endpoint, BSK_SAg_IL8, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL8. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is interleukins.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "interleukins", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 195, + "assayComponentName": "BSK_SAg_IL8", + "assayComponentDesc": "BSK_SAg_IL8 is an assay component measured in the BSK_SAg assay. It measures IL-8 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "IL-8 antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 8 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from T-cell Receptor (TCR) activation [GeneSymbol:CXCL8 | GeneID:3576 | Uniprot_SwissProt_Accession:P10145].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "IL-8 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 14, + "assayName": "BSK_SAg", + "assayDesc": "BSK_SAg is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 177, + "geneName": "chemokine (C-X-C motif) ligand 8", + "description": null, + "geneSymbol": "CXCL8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3576, + "officialSymbol": "CXCL8", + "officialFullName": "chemokine (C-X-C motif) ligand 8", + "uniprotAccessionNumber": "P10145" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 310, + "assayComponentEndpointName": "BSK_SAg_MCP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_SAg_MCP1 was analyzed into 1 assay endpoint. This assay endpoint, BSK_SAg_MCP1, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CCL2. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 196, + "assayComponentName": "BSK_SAg_MCP1", + "assayComponentDesc": "BSK_SAg_MCP1 is an assay component measured in the BSK_SAg assay. It measures MCP-1 antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MCP-1 antibody is used to tag and quantify the level of chemokine (C-C motif) ligand 2 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from T-cell Receptor (TCR) activation [GeneSymbol:CCL2 | GeneID:6347 | Uniprot_SwissProt_Accession:P13500].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MCP-1 antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 14, + "assayName": "BSK_SAg", + "assayDesc": "BSK_SAg is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 291, + "geneName": "chemokine (C-C motif) ligand 2", + "description": null, + "geneSymbol": "CCL2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6347, + "officialSymbol": "CCL2", + "officialFullName": "chemokine (C-C motif) ligand 2", + "uniprotAccessionNumber": "P13500" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 312, + "assayComponentEndpointName": "BSK_SAg_MIG", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_SAg_MIG was analyzed into 1 assay endpoint. This assay endpoint, BSK_SAg_MIG, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of binding reporter, gain or loss-of-signal activity can be used to understand changes in the signaling as they relate to the gene CXCL9. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cytokine intended target family, where the subfamily is chemotactic factor.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-specified", + "intendedTargetFamily": "cytokine", + "intendedTargetFamilySub": "chemotactic factor", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 197, + "assayComponentName": "BSK_SAg_MIG", + "assayComponentDesc": "BSK_SAg_MIG is an assay component measured in the BSK_SAg assay. It measures MIG antibody related to regulation of gene expression using ELISA technology.", + "assayComponentTargetDesc": "MIG antibody is used to tag and quantify the level of chemokine (C-X-C motif) ligand 9 protein. Changes in the signals are indicative of protein expression changes when conditioned to simulate proinflammation from T-cell Receptor (TCR) activation [GeneSymbol:CXCL9 | GeneID:4283 | Uniprot_SwissProt_Accession:Q07325].", + "parameterReadoutType": "single", + "assayDesignType": "binding reporter", + "assayDesignTypeSub": "immunoassay: elisa", + "biologicalProcessTarget": "regulation of gene expression", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "ELISA", + "keyAssayReagentType": "antibody", + "keyAssayReagent": "MIG antibody", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-specified", + "aid": 14, + "assayName": "BSK_SAg", + "assayDesc": "BSK_SAg is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": { + "geneId": 201, + "geneName": "chemokine (C-X-C motif) ligand 9", + "description": null, + "geneSymbol": "CXCL9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4283, + "officialSymbol": "CXCL9", + "officialFullName": "chemokine (C-X-C motif) ligand 9", + "uniprotAccessionNumber": "Q07325" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 314, + "assayComponentEndpointName": "BSK_SAg_PBMCCytotoxicity", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_SAg_PBMCCytotoxicity was analyzed into 1 assay endpoint. This assay endpoint, BSK_SAg_PBMCCytotoxicity, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, gain or loss-of-signal activity can be used to understand changes in the viability. \nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is cytotoxicity.", + "assayFunctionType": "viability", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "cytotoxicity", + "cellViabilityAssay": 1, + "dataUsability": 1, + "acid": 198, + "assayComponentName": "BSK_SAg_PBMCCytotoxicity", + "assayComponentDesc": "BSK_SAg_PBMCCytotoxicity is an assay component measured in the BSK_SAg assay. It measures Alamar blue related to cell death using Alamar Blue Reduction technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction involving the key substrate [Alamar blue] are correlated to the viability of the cells in the system.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "dehydrogenase activity determination", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Alamar Blue Reduction", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Alamar blue", + "technologicalTargetType": "cellular", + "technologicalTargetTypeSub": "cellular", + "aid": 14, + "assayName": "BSK_SAg", + "assayDesc": "BSK_SAg is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 316, + "assayComponentEndpointName": "BSK_SAg_Proliferation", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_SAg_Proliferation was analyzed into 1 assay endpoint. \nThis assay endpoint, BSK_SAg_Proliferation, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, measures of total protein for gain or loss-of-signal activity can be used to understand the viability at the cellular-level. \nFurthermore, this assay endpoint can be referred to as a secondary readout, because this assay has produced multiple assay endpoints where this one serves a viability function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell cycle intended target family, where the subfamily is proliferation.", + "assayFunctionType": "viability", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "cellular", + "intendedTargetTypeSub": "cellular", + "intendedTargetFamily": "cell cycle", + "intendedTargetFamilySub": "proliferation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 199, + "assayComponentName": "BSK_SAg_Proliferation", + "assayComponentDesc": "BSK_SAg_Proliferation is an assay component in the BSK_SAg assay. It measures protein content, a form of viability reporter, as detected with absorbance signals by Sulforhodamine staining technology. ", + "assayComponentTargetDesc": "0.1% sulforhodamine is used to tag and quantify the total protein levels in the system. Changes to these absorbance signals can be indicative of the viability in the system when conditioned to simulate proinflammation from T-cell Receptor (TCR) activation.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell proliferation", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 14, + "assayName": "BSK_SAg", + "assayDesc": "BSK_SAg is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 318, + "assayComponentEndpointName": "BSK_SAg_SRB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component BSK_SAg_SRB was analyzed into 1 assay endpoint. This assay endpoint, BSK_SAg_SRB, was analyzed with bidirectional fitting relative to DMSO as the negative control and baseline of activity. \nUsing a type of viability reporter, gain or loss-of-signal activity can be used to understand changes in the signaling. \nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a signaling function. \nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cell morphology intended target family, where the subfamily is cell conformation.", + "assayFunctionType": "signaling", + "normalizedDataType": "log10_fold_induction", + "burstAssay": 0, + "keyPositiveControl": "colchicine", + "signalDirection": "bidirectional", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "protein-unspecified", + "intendedTargetFamily": "cell morphology", + "intendedTargetFamilySub": "cell conformation", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 200, + "assayComponentName": "BSK_SAg_SRB", + "assayComponentDesc": "BSK_SAg_SRB is an assay component measured in the BSK_SAg assay. It measures protein content, a form of viability reporter, as detected with absorbance signals by Sulforhodamine staining technology.", + "assayComponentTargetDesc": "0.1% sulforhodamine is used to tag and quantify the total protein levels in the system. Changes to these absorbance signals can be indicative of the viability in the system when conditioned to simulate proinflammation from T-cell Receptor (TCR) activation.", + "parameterReadoutType": "single", + "assayDesignType": "viability reporter", + "assayDesignTypeSub": "protein content", + "biologicalProcessTarget": "cell death", + "detectionTechnologyType": "Spectrophotometry", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Sulforhodamine staining", + "keyAssayReagentType": "stain", + "keyAssayReagent": "0.1% sulforhodamine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "protein-unspecified", + "aid": 14, + "assayName": "BSK_SAg", + "assayDesc": "BSK_SAg is a cell-based, multiplexed-readout assay that uses umbilical vein endothelium and peripheral blood mononuclear cells, a human vascular primary cell co-culture, with measurements taken at 24 hours after chemical dosing in a 96-well plate.", + "timepointHr": 24.0, + "organismId": 9606, + "organism": "human", + "tissue": "vascular", + "cellFormat": "primary cell co-culture", + "cellFreeComponentSource": "NA", + "cellShortName": "umbilical vein endothelium and peripheral blood mononuclear cells", + "cellGrowthMode": "adherent", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "cell-based", + "assayFormatTypeSub": "cell-based format", + "contentReadoutType": "multiplexed", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.2, + "asid": 4, + "assaySourceName": "BSK", + "assaySourceLongName": "Bioseek", + "assaySourceDesc": "Bioseek is a division of DiscoveRx Corporation and developed the BioMAP system providing uniquely informative biological activity profiles in complex human primary cell systems.", + "gene": null, + "assayList": null, + "citations": { + "doi": "doi: 10.1177/1087057109345525", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/19773588", + "pmid": 19773588, + "title": "Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems", + "author": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL", + "citation": "Houck KA, Dix DJ, Judson RS, Kavlock RJ, Yang J, Berg EL. Profiling bioactivity of the ToxCast chemical library using BioMAP primary human cell systems. J Biomol Screen. 2009 Oct;14(9):1054-66. doi: 10.1177/1087057109345525. Epub 2009 Sep 22. PubMed PMID: 19773588.", + "otherId": "0", + "citationId": 213, + "otherSource": "" + } + }, + { + "aeid": 319, + "assayComponentEndpointName": "NVS_ADME_hCYP19A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP19A1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP19A1, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP19A1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is steroidogenesis-related.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ketoconazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "steroidogenesis-related", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 201, + "assayComponentName": "NVS_ADME_hCYP19A1", + "assayComponentDesc": "NVS_ADME_hCYP19A1 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP19A1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:DBOMF+ NADPH -> fluorescein + NADP+] involving the key substrate [Di(benzyloxymethoxy)fluorescein (DBOMF)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 19, subfamily A, polypeptide 1 [GeneSymbol:CYP19A1 | GeneID:1588 | Uniprot_SwissProt_Accession:P11511].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Di(benzyloxymethoxy)fluorescein (DBOMF)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 15, + "assayName": "NVS_ADME_hCYP19A1", + "assayDesc": "NVS_ADME_hCYP19A1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 384-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 94, + "geneName": "cytochrome P450, family 19, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP19A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1588, + "officialSymbol": "CYP19A1", + "officialFullName": "cytochrome P450, family 19, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "P11511" + }, + "assayList": { + "name": "EDSP steroidogenesis", + "description": "Steroidogenesis pathway assays used in EDSP" + }, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 321, + "assayComponentEndpointName": "NVS_ADME_hCYP1A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP1A1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP1A1, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP1A1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ketoconazole;Ketanserin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 202, + "assayComponentName": "NVS_ADME_hCYP1A1", + "assayComponentDesc": "NVS_ADME_hCYP1A1 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP1A1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BzRes + NADPH --> Res + NADP+] involving the key substrate [Resorufin Benzyl Ether (BzRes)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 1, subfamily A, polypeptide 1 [GeneSymbol:CYP1A1 | GeneID:1543 | Uniprot_SwissProt_Accession:P04798].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Resorufin Benzyl Ether (BzRes)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 16, + "assayName": "NVS_ADME_hCYP1A1", + "assayDesc": "NVS_ADME_hCYP1A1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 77, + "geneName": "cytochrome P450, family 1, subfamily A, polypeptide 1", + "description": null, + "geneSymbol": "CYP1A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1543, + "officialSymbol": "CYP1A1", + "officialFullName": "cytochrome P450, family 1, subfamily A, polypeptide 1", + "uniprotAccessionNumber": "P04798" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 323, + "assayComponentEndpointName": "NVS_ADME_hCYP1A2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP1A2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP1A2, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP1A2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Furafylline", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 203, + "assayComponentName": "NVS_ADME_hCYP1A2", + "assayComponentDesc": "NVS_ADME_hCYP1A2 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP1A2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:CEC + NADPH --> 7-hydroxy-3-cyanocoumarin (CHC) + NADP+] involving the key substrate [7-ethoxy-3-cyanocoumarin (CEC)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 1, subfamily A, polypeptide 2 [GeneSymbol:CYP1A2 | GeneID:1544 | Uniprot_SwissProt_Accession:P05177].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-ethoxy-3-cyanocoumarin (CEC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 17, + "assayName": "NVS_ADME_hCYP1A2", + "assayDesc": "NVS_ADME_hCYP1A2 is a biochemical, single-readout assay that uses extracted gene-proteins from insect cells in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 78, + "geneName": "cytochrome P450, family 1, subfamily A, polypeptide 2", + "description": null, + "geneSymbol": "CYP1A2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1544, + "officialSymbol": "CYP1A2", + "officialFullName": "cytochrome P450, family 1, subfamily A, polypeptide 2", + "uniprotAccessionNumber": "P05177" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "", + "pmid": 0, + "title": "High throughput screening for inhibition of cytochrome P450 metabolism", + "author": "Crespi CL, Miller VP, and Penman BW", + "citation": "Crespi CL, Miller VP, and Penman BW (1998) High throughput screening for inhibition of cytochrome P450 metabolism. Med Chem Res 8: 457-471.", + "otherId": "0", + "citationId": 203, + "otherSource": "" + } + }, + { + "aeid": 325, + "assayComponentEndpointName": "NVS_ADME_hCYP1B1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP1B1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP1B1, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP1B1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Alpha-Naphthoflavone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 204, + "assayComponentName": "NVS_ADME_hCYP1B1", + "assayComponentDesc": "NVS_ADME_hCYP1B1 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP1B1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BzRes + NADPH --> Res + NADP+] involving the key substrate [Resorufin Benzyl Ether (BzRes)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 1, subfamily B, polypeptide 1 [GeneSymbol:CYP1B1 | GeneID:1545 | Uniprot_SwissProt_Accession:Q16678].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Resorufin Benzyl Ether (BzRes)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 18, + "assayName": "NVS_ADME_hCYP1B1", + "assayDesc": "NVS_ADME_hCYP1B1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 79, + "geneName": "cytochrome P450, family 1, subfamily B, polypeptide 1", + "description": null, + "geneSymbol": "CYP1B1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1545, + "officialSymbol": "CYP1B1", + "officialFullName": "cytochrome P450, family 1, subfamily B, polypeptide 1", + "uniprotAccessionNumber": "Q16678" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 327, + "assayComponentEndpointName": "NVS_ADME_hCYP2A6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP2A6 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP2A6, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP2A6. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tranylcypromine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 205, + "assayComponentName": "NVS_ADME_hCYP2A6", + "assayComponentDesc": "NVS_ADME_hCYP2A6 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP2A6 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Coumarin + NADPH -> 7-Hydroxycoumarin + NADP+] involving the key substrate [Coumarin] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 2, subfamily A, polypeptide 6 [GeneSymbol:CYP2A6 | GeneID:1548 | Uniprot_SwissProt_Accession:P11509].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Coumarin", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 19, + "assayName": "NVS_ADME_hCYP2A6", + "assayDesc": "NVS_ADME_hCYP2A6 is a biochemical, single-readout assay that uses extracted gene-proteins from insect cells in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 80, + "geneName": "cytochrome P450, family 2, subfamily A, polypeptide 6", + "description": null, + "geneSymbol": "CYP2A6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1548, + "officialSymbol": "CYP2A6", + "officialFullName": "cytochrome P450, family 2, subfamily A, polypeptide 6", + "uniprotAccessionNumber": "P11509" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "", + "pmid": 0, + "title": "High throughput screening for inhibition of cytochrome P450 metabolism", + "author": "Crespi CL, Miller VP, and Penman BW", + "citation": "Crespi CL, Miller VP, and Penman BW (1998) High throughput screening for inhibition of cytochrome P450 metabolism. Med Chem Res 8: 457-471.", + "otherId": "0", + "citationId": 203, + "otherSource": "" + } + }, + { + "aeid": 329, + "assayComponentEndpointName": "NVS_ADME_hCYP2B6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP2B6 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP2B6, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP2B6. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Clotrimazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 206, + "assayComponentName": "NVS_ADME_hCYP2B6", + "assayComponentDesc": "NVS_ADME_hCYP2B6 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP2B6 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:EFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-ethoxy-4-trifluoromethylcoumarin (EFC)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 2, subfamily B, polypeptide 6 [GeneSymbol:CYP2B6 | GeneID:1555 | Uniprot_SwissProt_Accession:P20813].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-ethoxy-4-trifluoromethylcoumarin (EFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 20, + "assayName": "NVS_ADME_hCYP2B6", + "assayDesc": "NVS_ADME_hCYP2B6 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 82, + "geneName": "cytochrome P450, family 2, subfamily B, polypeptide 6", + "description": null, + "geneSymbol": "CYP2B6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1555, + "officialSymbol": "CYP2B6", + "officialFullName": "cytochrome P450, family 2, subfamily B, polypeptide 6", + "uniprotAccessionNumber": "P20813" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 331, + "assayComponentEndpointName": "NVS_ADME_hCYP2C18", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP2C18 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP2C18, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP2C18. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tranylcypromine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 207, + "assayComponentName": "NVS_ADME_hCYP2C18", + "assayComponentDesc": "NVS_ADME_hCYP2C18 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP2C18 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:MFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-methoxy-4-trifluoromethylcoumarin (MFC)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 2, subfamily C, polypeptide 18 [GeneSymbol:CYP2C18 | GeneID:1562 | Uniprot_SwissProt_Accession:P33260].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-methoxy-4-trifluoromethylcoumarin (MFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 21, + "assayName": "NVS_ADME_hCYP2C18", + "assayDesc": "NVS_ADME_hCYP2C18 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 86, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 18", + "description": null, + "geneSymbol": "CYP2C18", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1562, + "officialSymbol": "CYP2C18", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 18", + "uniprotAccessionNumber": "P33260" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 333, + "assayComponentEndpointName": "NVS_ADME_hCYP2C19", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP2C19 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP2C19, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP2C19. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tranylcypromine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 208, + "assayComponentName": "NVS_ADME_hCYP2C19", + "assayComponentDesc": "NVS_ADME_hCYP2C19 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP2C19 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:CEC + NADPH --> 7-hydroxy-3-cyanocoumarin (CHC) + NADP+] involving the key substrate [7-ethoxy-3-cyanocoumarin (CEC)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 2, subfamily C, polypeptide 19 [GeneSymbol:CYP2C19 | GeneID:1557 | Uniprot_SwissProt_Accession:P33261].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-ethoxy-3-cyanocoumarin (CEC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 22, + "assayName": "NVS_ADME_hCYP2C19", + "assayDesc": "NVS_ADME_hCYP2C19 is a biochemical, single-readout assay that uses extracted gene-proteins from insect cells in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 83, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "description": null, + "geneSymbol": "CYP2C19", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1557, + "officialSymbol": "CYP2C19", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 19", + "uniprotAccessionNumber": "P33261" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "", + "pmid": 0, + "title": "High throughput screening for inhibition of cytochrome P450 metabolism", + "author": "Crespi CL, Miller VP, and Penman BW", + "citation": "Crespi CL, Miller VP, and Penman BW (1998) High throughput screening for inhibition of cytochrome P450 metabolism. Med Chem Res 8: 457-471.", + "otherId": "0", + "citationId": 203, + "otherSource": "" + } + }, + { + "aeid": 335, + "assayComponentEndpointName": "NVS_ADME_hCYP2C8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP2C8 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP2C8, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP2C8. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "quercetin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 209, + "assayComponentName": "NVS_ADME_hCYP2C8", + "assayComponentDesc": "NVS_ADME_hCYP2C8 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP2C8 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:DBOMF+ NADPH -> fluorescein + NADP+] involving the key substrate [Di(benzyloxymethoxy)fluorescein (DBOMF)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 2, subfamily C, polypeptide 8 [GeneSymbol:CYP2C8 | GeneID:1558 | Uniprot_SwissProt_Accession:P10632].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Di(benzyloxymethoxy)fluorescein (DBOMF)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 23, + "assayName": "NVS_ADME_hCYP2C8", + "assayDesc": "NVS_ADME_hCYP2C8 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 84, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 8", + "description": null, + "geneSymbol": "CYP2C8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1558, + "officialSymbol": "CYP2C8", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 8", + "uniprotAccessionNumber": "P10632" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 337, + "assayComponentEndpointName": "NVS_ADME_hCYP2C9", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP2C9 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP2C9, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP2C9. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Sulfaphenazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 210, + "assayComponentName": "NVS_ADME_hCYP2C9", + "assayComponentDesc": "NVS_ADME_hCYP2C9 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP2C9 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:MFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-methoxy-4-trifluoromethylcoumarin (MFC)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 2, subfamily C, polypeptide 9 [GeneSymbol:CYP2C9 | GeneID:1559 | Uniprot_SwissProt_Accession:P11712].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-methoxy-4-trifluoromethylcoumarin (MFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 24, + "assayName": "NVS_ADME_hCYP2C9", + "assayDesc": "NVS_ADME_hCYP2C9 is a biochemical, single-readout assay that uses extracted gene-proteins from SF9 in a cell-free assay. Measurements were taken 0.75 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.75, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "SF9", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 85, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 9", + "description": null, + "geneSymbol": "CYP2C9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1559, + "officialSymbol": "CYP2C9", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 9", + "uniprotAccessionNumber": "P11712" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "", + "pmid": 0, + "title": "High throughput screening for inhibition of cytochrome P450 metabolism", + "author": "Crespi CL, Miller VP, and Penman BW", + "citation": "Crespi CL, Miller VP, and Penman BW (1998) High throughput screening for inhibition of cytochrome P450 metabolism. Med Chem Res 8: 457-471.", + "otherId": "0", + "citationId": 203, + "otherSource": "" + } + }, + { + "aeid": 339, + "assayComponentEndpointName": "NVS_ADME_hCYP2D6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP2D6 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP2D6, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP2D6. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "quinidine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 211, + "assayComponentName": "NVS_ADME_hCYP2D6", + "assayComponentDesc": "NVS_ADME_hCYP2D6 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP2D6 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:AMMC + NADPH --> AHMC + NADP+] involving the key substrate [3-[2-(N,N-diethyl-N-methylamino)ethyl]-7-methoxy-4-methylcoumarin (AMMC)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 2, subfamily D, polypeptide 6 [GeneSymbol:CYP2D6 | GeneID:1565 | Uniprot_SwissProt_Accession:P10635].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "3-[2-(N,N-diethyl-N-methylamino)ethyl]-7-methoxy-4-methylcoumarin (AMMC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 25, + "assayName": "NVS_ADME_hCYP2D6", + "assayDesc": "NVS_ADME_hCYP2D6 is a biochemical, single-readout assay that uses extracted gene-proteins from insect cells in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 87, + "geneName": "cytochrome P450, family 2, subfamily D, polypeptide 6", + "description": null, + "geneSymbol": "CYP2D6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1565, + "officialSymbol": "CYP2D6", + "officialFullName": "cytochrome P450, family 2, subfamily D, polypeptide 6", + "uniprotAccessionNumber": "P10635" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "", + "pmid": 0, + "title": "High throughput screening for inhibition of cytochrome P450 metabolism", + "author": "Crespi CL, Miller VP, and Penman BW", + "citation": "Crespi CL, Miller VP, and Penman BW (1998) High throughput screening for inhibition of cytochrome P450 metabolism. Med Chem Res 8: 457-471.", + "otherId": "0", + "citationId": 203, + "otherSource": "" + } + }, + { + "aeid": 341, + "assayComponentEndpointName": "NVS_ADME_hCYP2E1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP2E1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP2E1, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP2E1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "chlormethiazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 212, + "assayComponentName": "NVS_ADME_hCYP2E1", + "assayComponentDesc": "NVS_ADME_hCYP2E1 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP2E1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:MFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-methoxy-4-trifluoromethylcoumarin (MFC)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 2, subfamily E, polypeptide 1 [GeneSymbol:CYP2E1 | GeneID:1571 | Uniprot_SwissProt_Accession:P05181].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-methoxy-4-trifluoromethylcoumarin (MFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 26, + "assayName": "NVS_ADME_hCYP2E1", + "assayDesc": "NVS_ADME_hCYP2E1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 88, + "geneName": "cytochrome P450, family 2, subfamily E, polypeptide 1", + "description": null, + "geneSymbol": "CYP2E1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1571, + "officialSymbol": "CYP2E1", + "officialFullName": "cytochrome P450, family 2, subfamily E, polypeptide 1", + "uniprotAccessionNumber": "P05181" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 343, + "assayComponentEndpointName": "NVS_ADME_hCYP2J2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP2J2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP2J2, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP2J2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ketoconazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 213, + "assayComponentName": "NVS_ADME_hCYP2J2", + "assayComponentDesc": "NVS_ADME_hCYP2J2 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP2J2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BOMFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-(benzyloxymethoxy)-4-(trifluormethyl)-2H-coumarin (BOMFC)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 2, subfamily J, polypeptide 2 [GeneSymbol:CYP2J2 | GeneID:1573 | Uniprot_SwissProt_Accession:P51589].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-(benzyloxymethoxy)-4-(trifluormethyl)-2H-coumarin (BOMFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 27, + "assayName": "NVS_ADME_hCYP2J2", + "assayDesc": "NVS_ADME_hCYP2J2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 89, + "geneName": "cytochrome P450, family 2, subfamily J, polypeptide 2", + "description": null, + "geneSymbol": "CYP2J2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1573, + "officialSymbol": "CYP2J2", + "officialFullName": "cytochrome P450, family 2, subfamily J, polypeptide 2", + "uniprotAccessionNumber": "P51589" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 345, + "assayComponentEndpointName": "NVS_ADME_hCYP3A4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP3A4 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP3A4, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP3A4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ketoconazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 214, + "assayComponentName": "NVS_ADME_hCYP3A4", + "assayComponentDesc": "NVS_ADME_hCYP3A4 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP3A4 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:DBF + NADPH --> fluorescein + NADP+] involving the key substrate [Dibenzyl fluorescein (DBF)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 3, subfamily A, polypeptide 4 [GeneSymbol:CYP3A4 | GeneID:1576 | Uniprot_SwissProt_Accession:P08684].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Dibenzyl fluorescein (DBF)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 28, + "assayName": "NVS_ADME_hCYP3A4", + "assayDesc": "NVS_ADME_hCYP3A4 is a biochemical, single-readout assay that uses extracted gene-proteins from insect cells in a cell-free assay. Measurements were taken 0.33 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 90, + "geneName": "cytochrome P450, family 3, subfamily A, polypeptide 4", + "description": null, + "geneSymbol": "CYP3A4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1576, + "officialSymbol": "CYP3A4", + "officialFullName": "cytochrome P450, family 3, subfamily A, polypeptide 4", + "uniprotAccessionNumber": "P08684" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "", + "pmid": 0, + "title": "High throughput screening for inhibition of cytochrome P450 metabolism", + "author": "Crespi CL, Miller VP, and Penman BW", + "citation": "Crespi CL, Miller VP, and Penman BW (1998) High throughput screening for inhibition of cytochrome P450 metabolism. Med Chem Res 8: 457-471.", + "otherId": "0", + "citationId": 203, + "otherSource": "" + } + }, + { + "aeid": 347, + "assayComponentEndpointName": "NVS_ADME_hCYP3A5", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP3A5 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP3A5, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP3A5. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ketoconazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 215, + "assayComponentName": "NVS_ADME_hCYP3A5", + "assayComponentDesc": "NVS_ADME_hCYP3A5 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP3A5 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BOMFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-(benzyloxymethoxy)-4-(trifluormethyl)-2H-coumarin (BOMFC)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 3, subfamily A, polypeptide 5 [GeneSymbol:CYP3A5 | GeneID:1577 | Uniprot_SwissProt_Accession:P20815].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-(benzyloxymethoxy)-4-(trifluormethyl)-2H-coumarin (BOMFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 29, + "assayName": "NVS_ADME_hCYP3A5", + "assayDesc": "NVS_ADME_hCYP3A5 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 91, + "geneName": "cytochrome P450, family 3, subfamily A, polypeptide 5", + "description": null, + "geneSymbol": "CYP3A5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1577, + "officialSymbol": "CYP3A5", + "officialFullName": "cytochrome P450, family 3, subfamily A, polypeptide 5", + "uniprotAccessionNumber": "P20815" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "", + "pmid": 0, + "title": "High throughput screening for inhibition of cytochrome P450 metabolism", + "author": "Crespi CL, Miller VP, and Penman BW", + "citation": "Crespi CL, Miller VP, and Penman BW (1998) High throughput screening for inhibition of cytochrome P450 metabolism. Med Chem Res 8: 457-471.", + "otherId": "0", + "citationId": 203, + "otherSource": "" + } + }, + { + "aeid": 349, + "assayComponentEndpointName": "NVS_ADME_hCYP4F12", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_hCYP4F12 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_hCYP4F12, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CYP4F12. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ketoconazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 216, + "assayComponentName": "NVS_ADME_hCYP4F12", + "assayComponentDesc": "NVS_ADME_hCYP4F12 is one of one assay component(s) measured or calculated from the NVS_ADME_hCYP4F12 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BzRes + NADPH --> Res + NADP+] involving the key substrate [Resorufin Benzyl Ether (BzRes)] are indicative of changes in enzyme function and kinetics for the human cytochrome P450, family 4, subfamily F, polypeptide 12 [GeneSymbol:CYP4F12 | GeneID:66002 | Uniprot_SwissProt_Accession:Q9HCS2].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Resorufin Benzyl Ether (BzRes)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 30, + "assayName": "NVS_ADME_hCYP4F12", + "assayDesc": "NVS_ADME_hCYP4F12 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 384-well plate.", + "timepointHr": 0.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 434, + "geneName": "cytochrome P450, family 4, subfamily F, polypeptide 12", + "description": null, + "geneSymbol": "CYP4F12", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 66002, + "officialSymbol": "CYP4F12", + "officialFullName": "cytochrome P450, family 4, subfamily F, polypeptide 12", + "uniprotAccessionNumber": "Q9HCS2" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 351, + "assayComponentEndpointName": "NVS_ADME_rCYP1A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP1A1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP1A1, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp1a1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "ellipticine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 217, + "assayComponentName": "NVS_ADME_rCYP1A1", + "assayComponentDesc": "NVS_ADME_rCYP1A1 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP1A1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BzRes + NADPH --> Res + NADP+] involving the key substrate [Resorufin Benzyl Ether (BzRes)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 1, subfamily a, polypeptide 1 [GeneSymbol:Cyp1a1 | GeneID:24296 | Uniprot_SwissProt_Accession:P00185].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Resorufin Benzyl Ether (BzRes)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 31, + "assayName": "NVS_ADME_rCYP1A1", + "assayDesc": "NVS_ADME_rCYP1A1 is a biochemical, single-readout assay that uses extracted gene-proteins from baculovirus-insect cells in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "baculovirus-insect cells", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 384, + "geneName": "cytochrome P450, family 1, subfamily a, polypeptide 1", + "description": null, + "geneSymbol": "Cyp1a1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24296, + "officialSymbol": "Cyp1a1", + "officialFullName": "cytochrome P450, family 1, subfamily a, polypeptide 1", + "uniprotAccessionNumber": "P00185" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 353, + "assayComponentEndpointName": "NVS_ADME_rCYP1A2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP1A2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP1A2, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp1a2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Alpha-Naphthoflavone", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 218, + "assayComponentName": "NVS_ADME_rCYP1A2", + "assayComponentDesc": "NVS_ADME_rCYP1A2 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP1A2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:CEC + NADPH --> 7-hydroxy-3-cyanocoumarin (CHC) + NADP+] involving the key substrate [7-ethoxy-3-cyanocoumarin (CEC)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 1, subfamily a, polypeptide 2 [GeneSymbol:Cyp1a2 | GeneID:24297 | Uniprot_SwissProt_Accession:P04799].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-ethoxy-3-cyanocoumarin (CEC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 32, + "assayName": "NVS_ADME_rCYP1A2", + "assayDesc": "NVS_ADME_rCYP1A2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 385, + "geneName": "cytochrome P450, family 1, subfamily a, polypeptide 2", + "description": null, + "geneSymbol": "Cyp1a2", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24297, + "officialSymbol": "Cyp1a2", + "officialFullName": "cytochrome P450, family 1, subfamily a, polypeptide 2", + "uniprotAccessionNumber": "P04799" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 355, + "assayComponentEndpointName": "NVS_ADME_rCYP2A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP2A1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP2A1, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp2a1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Clotrimazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 219, + "assayComponentName": "NVS_ADME_rCYP2A1", + "assayComponentDesc": "NVS_ADME_rCYP2A1 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP2A1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BOMCC + NADPH --> 7-hydroxy-3-cyanocoumarin (CHC) + NADP+] involving the key substrate [7-benzyloxymethoxy-3-cyanocoumarin (BOMCC)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 2, subfamily a, polypeptide 1 [GeneSymbol:Cyp2a1 | GeneID:24894 | Uniprot_SwissProt_Accession:P11711].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-benzyloxymethoxy-3-cyanocoumarin (BOMCC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 33, + "assayName": "NVS_ADME_rCYP2A1", + "assayDesc": "NVS_ADME_rCYP2A1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.75 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.75, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 396, + "geneName": "cytochrome P450, family 2, subfamily a, polypeptide 1", + "description": null, + "geneSymbol": "Cyp2a1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24894, + "officialSymbol": "Cyp2a1", + "officialFullName": "cytochrome P450, family 2, subfamily a, polypeptide 1", + "uniprotAccessionNumber": "P11711" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "", + "pmid": 0, + "title": "High throughput screening for inhibition of cytochrome P450 metabolism", + "author": "Crespi CL, Miller VP, and Penman BW", + "citation": "Crespi CL, Miller VP, and Penman BW (1998) High throughput screening for inhibition of cytochrome P450 metabolism. Med Chem Res 8: 457-471.", + "otherId": "0", + "citationId": 203, + "otherSource": "" + } + }, + { + "aeid": 357, + "assayComponentEndpointName": "NVS_ADME_rCYP2A2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP2A2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP2A2, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp2a2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ketoconazole;Tranylcypromine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 220, + "assayComponentName": "NVS_ADME_rCYP2A2", + "assayComponentDesc": "NVS_ADME_rCYP2A2 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP2A2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-benzyloxy-4-trifluoromethylcoumarin (BFC)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 2, subfamily a, polypeptide 2 [GeneSymbol:Cyp2a2 | GeneID:24895 | Uniprot_SwissProt_Accession:P15149].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-benzyloxy-4-trifluoromethylcoumarin (BFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 34, + "assayName": "NVS_ADME_rCYP2A2", + "assayDesc": "NVS_ADME_rCYP2A2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.2 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.2, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 397, + "geneName": "cytochrome P450, family 2, subfamily a, polypeptide 2", + "description": null, + "geneSymbol": "Cyp2a2", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24895, + "officialSymbol": "Cyp2a2", + "officialFullName": "cytochrome P450, family 2, subfamily a, polypeptide 2", + "uniprotAccessionNumber": "P15149" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 359, + "assayComponentEndpointName": "NVS_ADME_rCYP2B1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP2B1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP2B1, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp2b1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ketoconazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 221, + "assayComponentName": "NVS_ADME_rCYP2B1", + "assayComponentDesc": "NVS_ADME_rCYP2B1 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP2B1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-benzyloxy-4-trifluoromethylcoumarin (BFC)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 2, subfamily b, polypeptide 1 [GeneSymbol:Cyp2b1 | GeneID:24300 | Uniprot_SwissProt_Accession:P00176].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-benzyloxy-4-trifluoromethylcoumarin (BFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 35, + "assayName": "NVS_ADME_rCYP2B1", + "assayDesc": "NVS_ADME_rCYP2B1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.75 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.75, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 386, + "geneName": "cytochrome P450, family 2, subfamily b, polypeptide 1", + "description": null, + "geneSymbol": "Cyp2b1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 24300, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P00176" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 361, + "assayComponentEndpointName": "NVS_ADME_rCYP2C11", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP2C11 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP2C11, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp2c11. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ketoconazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 222, + "assayComponentName": "NVS_ADME_rCYP2C11", + "assayComponentDesc": "NVS_ADME_rCYP2C11 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP2C11 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:MFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-methoxy-4-trifluoromethylcoumarin (MFC)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, subfamily 2, polypeptide 11 [GeneSymbol:Cyp2c11 | GeneID:29277 | Uniprot_SwissProt_Accession:P08683].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-methoxy-4-trifluoromethylcoumarin (MFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 36, + "assayName": "NVS_ADME_rCYP2C11", + "assayDesc": "NVS_ADME_rCYP2C11 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.33 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.33, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 418, + "geneName": "cytochrome P450, subfamily 2, polypeptide 11", + "description": null, + "geneSymbol": "Cyp2c11", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 29277, + "officialSymbol": "Cyp2c11", + "officialFullName": "cytochrome P450, subfamily 2, polypeptide 11", + "uniprotAccessionNumber": "P08683" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 363, + "assayComponentEndpointName": "NVS_ADME_rCYP2C12", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP2C12 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP2C12, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp2c12. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tranylcypromine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 223, + "assayComponentName": "NVS_ADME_rCYP2C12", + "assayComponentDesc": "NVS_ADME_rCYP2C12 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP2C12 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BOMCC + NADPH --> 7-hydroxy-3-cyanocoumarin (CHC) + NADP+] involving the key substrate [7-benzyloxymethoxy-3-cyanocoumarin (BOMCC)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 2, subfamily c, polypeptide 12 [GeneSymbol:Cyp2c12 | GeneID:25011 | Uniprot_SwissProt_Accession:P11510].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-benzyloxymethoxy-3-cyanocoumarin (BOMCC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 37, + "assayName": "NVS_ADME_rCYP2C12", + "assayDesc": "NVS_ADME_rCYP2C12 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.5, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 399, + "geneName": "cytochrome P450, family 2, subfamily c, polypeptide 12", + "description": null, + "geneSymbol": "Cyp2c12", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25011, + "officialSymbol": "Cyp2c12", + "officialFullName": "cytochrome P450, family 2, subfamily c, polypeptide 12", + "uniprotAccessionNumber": "P11510" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 365, + "assayComponentEndpointName": "NVS_ADME_rCYP2C13", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP2C13 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP2C13, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp2c13. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Clotrimazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 224, + "assayComponentName": "NVS_ADME_rCYP2C13", + "assayComponentDesc": "NVS_ADME_rCYP2C13 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP2C13 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-benzyloxy-4-trifluoromethylcoumarin (BFC)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 2, subfamily c, polypeptide 13 [GeneSymbol:Cyp2c13 | GeneID:171521 | Uniprot_SwissProt_Accession:P20814].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-benzyloxy-4-trifluoromethylcoumarin (BFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 38, + "assayName": "NVS_ADME_rCYP2C13", + "assayDesc": "NVS_ADME_rCYP2C13 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.75 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.75, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 445, + "geneName": "cytochrome P450, family 2, subfamily c, polypeptide 13", + "description": "provisional", + "geneSymbol": "Cyp2c13", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 171521, + "officialSymbol": null, + "officialFullName": null, + "uniprotAccessionNumber": "P20814" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7744763", + "pmid": 7744763, + "title": "Characterization of orphan nuclear receptor binding elements in sex-differentiated members of the CYP2C gene family expressed in rat liver", + "author": "Ström A, Westin S, Eguchi H, Gustafsson JA, Mode A", + "citation": "Ström A, Westin S, Eguchi H, Gustafsson JA, Mode A. Characterization of orphan nuclear receptor binding elements in sex-differentiated members of the CYP2C gene family expressed in rat liver. J Biol Chem. 1995 May 12;270(19):11276-81. PubMed PMID: 7744763.", + "otherId": "0", + "citationId": 146, + "otherSource": "" + } + }, + { + "aeid": 367, + "assayComponentEndpointName": "NVS_ADME_rCYP2C6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP2C6 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP2C6, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp2c6v1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ketoconazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 225, + "assayComponentName": "NVS_ADME_rCYP2C6", + "assayComponentDesc": "NVS_ADME_rCYP2C6 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP2C6 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:MFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-methoxy-4-trifluoromethylcoumarin (MFC)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 2, subfamily C, polypeptide 6, variant 1 [GeneSymbol:Cyp2c6v1 | GeneID:293989 | Uniprot_SwissProt_Accession:P05178].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-methoxy-4-trifluoromethylcoumarin (MFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 39, + "assayName": "NVS_ADME_rCYP2C6", + "assayDesc": "NVS_ADME_rCYP2C6 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 453, + "geneName": "cytochrome P450, family 2, subfamily C, polypeptide 6, variant 1", + "description": null, + "geneSymbol": "Cyp2c6v1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 293989, + "officialSymbol": "Cyp2c6v1", + "officialFullName": "cytochrome P450, family 2, subfamily C, polypeptide 6, variant 1", + "uniprotAccessionNumber": "P05178" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 369, + "assayComponentEndpointName": "NVS_ADME_rCYP2D1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP2D1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP2D1, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp2d1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Propranolol HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 226, + "assayComponentName": "NVS_ADME_rCYP2D1", + "assayComponentDesc": "NVS_ADME_rCYP2D1 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP2D1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:DBF + NADPH --> fluorescein + NADP+] involving the key substrate [Dibenzyl Fluorescein (DBF)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 2, subfamily d, polypeptide 1 [GeneSymbol:Cyp2d1 | GeneID:266684 | Uniprot_SwissProt_Accession:P10633].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Dibenzyl Fluorescein (DBF)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 40, + "assayName": "NVS_ADME_rCYP2D1", + "assayDesc": "NVS_ADME_rCYP2D1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.75 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.75, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 448, + "geneName": "cytochrome P450, family 2, subfamily d, polypeptide 1", + "description": null, + "geneSymbol": "Cyp2d1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 266684, + "officialSymbol": "Cyp2d1", + "officialFullName": "cytochrome P450, family 2, subfamily d, polypeptide 1", + "uniprotAccessionNumber": "P10633" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 371, + "assayComponentEndpointName": "NVS_ADME_rCYP2D2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP2D2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP2D2, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp2d2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Propranolol HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 227, + "assayComponentName": "NVS_ADME_rCYP2D2", + "assayComponentDesc": "NVS_ADME_rCYP2D2 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP2D2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:AMMC + NADPH --> AHMC + NADP+] involving the key substrate [3-[2-(N,N-diethyl-N-methylamino)ethyl]-7-methoxy-4-methylcoumarin (AMMC)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 2, subfamily d, polypeptide 2 [GeneSymbol:Cyp2d2 | GeneID:25053 | Uniprot_SwissProt_Accession:P10634].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "3-[2-(N,N-diethyl-N-methylamino)ethyl]-7-methoxy-4-methylcoumarin (AMMC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 41, + "assayName": "NVS_ADME_rCYP2D2", + "assayDesc": "NVS_ADME_rCYP2D2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.75 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.75, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 401, + "geneName": "cytochrome P450, family 2, subfamily d, polypeptide 2", + "description": null, + "geneSymbol": "Cyp2d2", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25053, + "officialSymbol": "Cyp2d2", + "officialFullName": "cytochrome P450, family 2, subfamily d, polypeptide 2", + "uniprotAccessionNumber": "P10634" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 373, + "assayComponentEndpointName": "NVS_ADME_rCYP2E1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP2E1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP2E1, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp2e1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "chlormethiazole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 228, + "assayComponentName": "NVS_ADME_rCYP2E1", + "assayComponentDesc": "NVS_ADME_rCYP2E1 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP2E1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:MFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-methoxy-4-trifluoromethylcoumarin (MFC)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 2, subfamily e, polypeptide 1 [GeneSymbol:Cyp2e1 | GeneID:25086 | Uniprot_SwissProt_Accession:P05182].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-methoxy-4-trifluoromethylcoumarin (MFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 42, + "assayName": "NVS_ADME_rCYP2E1", + "assayDesc": "NVS_ADME_rCYP2E1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 403, + "geneName": "cytochrome P450, family 2, subfamily e, polypeptide 1", + "description": null, + "geneSymbol": "Cyp2e1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25086, + "officialSymbol": "Cyp2e1", + "officialFullName": "cytochrome P450, family 2, subfamily e, polypeptide 1", + "uniprotAccessionNumber": "P05182" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 375, + "assayComponentEndpointName": "NVS_ADME_rCYP3A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP3A1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP3A1, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp3a23/3a1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "(+/-) Verapamil HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 229, + "assayComponentName": "NVS_ADME_rCYP3A1", + "assayComponentDesc": "NVS_ADME_rCYP3A1 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP3A1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-benzyloxy-4-trifluoromethylcoumarin (BFC)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 3, subfamily a, polypeptide 23/polypeptide 1 [GeneSymbol:Cyp3a23/3a1 | GeneID:25642 | Uniprot_SwissProt_Accession:P04800].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-benzyloxy-4-trifluoromethylcoumarin (BFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 43, + "assayName": "NVS_ADME_rCYP3A1", + "assayDesc": "NVS_ADME_rCYP3A1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.5, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 412, + "geneName": "cytochrome P450, family 3, subfamily a, polypeptide 23/polypeptide 1", + "description": null, + "geneSymbol": "Cyp3a23/3a1", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 25642, + "officialSymbol": "Cyp3a23/3a1", + "officialFullName": "cytochrome P450, family 3, subfamily a, polypeptide 23/polypeptide 1", + "uniprotAccessionNumber": "P04800" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 377, + "assayComponentEndpointName": "NVS_ADME_rCYP3A2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ADME_rCYP3A2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ADME_rCYP3A2, was analyzed in the positive analysis fitting direction relative to Acetonitrile as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene Cyp3a2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the cyp intended target family, where the subfamily is xenobiotic metabolism.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "(+/-) Verapamil HCl", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "cyp", + "intendedTargetFamilySub": "xenobiotic metabolism", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 230, + "assayComponentName": "NVS_ADME_rCYP3A2", + "assayComponentDesc": "NVS_ADME_rCYP3A2 is one of one assay component(s) measured or calculated from the NVS_ADME_rCYP3A2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:BFC + NADPH --> 7-hydroxy-4-trifluoromethylcoumarin (7-HFC) + NADP+] involving the key substrate [7-benzyloxy-4-trifluoromethylcoumarin (BFC)] are indicative of changes in enzyme function and kinetics for the Norway rat cytochrome P450, family 3, subfamily a, polypeptide 2 [GeneSymbol:Cyp3a2 | GeneID:266682 | Uniprot_SwissProt_Accession:P05183].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-benzyloxy-4-trifluoromethylcoumarin (BFC)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 44, + "assayName": "NVS_ADME_rCYP3A2", + "assayDesc": "NVS_ADME_rCYP3A2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.5 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.5, + "organismId": 10116, + "organism": "rat", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "Acetonitrile", + "dilutionSolventPercentMax": 2.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 447, + "geneName": "cytochrome P450, family 3, subfamily a, polypeptide 2", + "description": null, + "geneSymbol": "Cyp3a2", + "organismId": 3, + "trackStatus": "live", + "entrezGeneId": 266682, + "officialSymbol": "Cyp3a2", + "officialFullName": "cytochrome P450, family 3, subfamily a, polypeptide 2", + "uniprotAccessionNumber": "P05183" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/12065444", + "pmid": 12065444, + "title": "Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4", + "author": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL", + "citation": "Stresser DM, Turner SD, Blanchard AP, Miller VP, Crespi CL. Cytochrome P450 fluorometric substrates: identification of isoform-selective probes for rat CYP2D2 and human CYP3A4. Drug Metab Dispos. 2002 Jul;30(7):845-52. PubMed PMID: 12065444.", + "otherId": "0", + "citationId": 191, + "otherSource": "" + } + }, + { + "aeid": 379, + "assayComponentEndpointName": "NVS_ENZ_hAbl", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hAbl was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hAbl, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene ABL1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 231, + "assayComponentName": "NVS_ENZ_hAbl", + "assayComponentDesc": "NVS_ENZ_hAbl is one of one assay component(s) measured or calculated from the NVS_ENZ_hAbl assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human ABL proto-oncogene 1, non-receptor tyrosine kinase [GeneSymbol:ABL1 | GeneID:25 | Uniprot_SwissProt_Accession:P00519].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 45, + "assayName": "NVS_ENZ_hAbl", + "assayDesc": "NVS_ENZ_hAbl is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 1, + "geneName": "ABL proto-oncogene 1, non-receptor tyrosine kinase", + "description": null, + "geneSymbol": "ABL1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 25, + "officialSymbol": "ABL1", + "officialFullName": "ABL proto-oncogene 1, non-receptor tyrosine kinase", + "uniprotAccessionNumber": "P00519" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/6304726", + "pmid": 6304726, + "title": "Nucleotide sequence of Abelson murine leukemia virus genome: structural similarity of its transforming gene product to other onc gene products with tyrosine-specific kinase activity", + "author": "Reddy EP, Smith MJ, Srinivasan A", + "citation": "Reddy EP, Smith MJ, Srinivasan A. Nucleotide sequence of Abelson murine leukemia virus genome: structural similarity of its transforming gene product to other onc gene products with tyrosine-specific kinase activity. Proc Natl Acad Sci U S A. 1983 Jun;80(12):3623-7. PubMed PMID: 6304726; PubMed Central PMCID: PMC394102.", + "otherId": "0", + "citationId": 118, + "otherSource": "" + } + }, + { + "aeid": 381, + "assayComponentEndpointName": "NVS_ENZ_hAChE", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hAChE was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hAChE, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene ACHE. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is acetylcholinesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "physostigmine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "acetylcholinesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 232, + "assayComponentName": "NVS_ENZ_hAChE", + "assayComponentDesc": "NVS_ENZ_hAChE is one of one assay component(s) measured or calculated from the NVS_ENZ_hAChE assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by Colorimetric technology.", + "assayComponentTargetDesc": "Changes to absorbance signals produced from an enzymatic reaction [Reaction:Acetylthiocholine-->Acetate +Thiocholine | Thiocholine + DTNB (Ellman\"s Reagent)--> 5-thio-2-nitrobenzoic acid (yellow)] involving the key substrate [acetylthiocholine] are indicative of changes in enzyme function and kinetics for the human acetylcholinesterase (Yt blood group) [GeneSymbol:ACHE | GeneID:43 | Uniprot_SwissProt_Accession:P22303].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Colorimetric", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "acetylthiocholine", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 46, + "assayName": "NVS_ENZ_hAChE", + "assayDesc": "NVS_ENZ_hAChE is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0.33 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.33, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 2, + "geneName": "acetylcholinesterase (Yt blood group)", + "description": null, + "geneSymbol": "ACHE", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 43, + "officialSymbol": "ACHE", + "officialFullName": "acetylcholinesterase (Yt blood group)", + "uniprotAccessionNumber": "P22303" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/13726518", + "pmid": 13726518, + "title": "A new and rapid colorimetric determination of acetylcholinesterase activity", + "author": "ELLMAN GL, COURTNEY KD, ANDRES V Jr, FEATHER-STONE RM", + "citation": "ELLMAN GL, COURTNEY KD, ANDRES V Jr, FEATHER-STONE RM. A new and rapid colorimetric determination of acetylcholinesterase activity. Biochem Pharmacol. 1961 Jul;7:88-95. PubMed PMID: 13726518.", + "otherId": "0", + "citationId": 197, + "otherSource": "" + } + }, + { + "aeid": 383, + "assayComponentEndpointName": "NVS_ENZ_hACP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hACP1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hACP1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene ACP1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is acid phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "acid phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 233, + "assayComponentName": "NVS_ENZ_hACP1", + "assayComponentDesc": "NVS_ENZ_hACP1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hACP1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-phosphopeptide --> fluorescein-peptide] involving the key substrate [Fluorescein-labeled phosphopeptide] are indicative of changes in enzyme function and kinetics for the human acid phosphatase 1, soluble [GeneSymbol:ACP1 | GeneID:52 | Uniprot_SwissProt_Accession:P24666].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled phosphopeptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 47, + "assayName": "NVS_ENZ_hACP1", + "assayDesc": "NVS_ENZ_hACP1 is a biochemical, single-readout assay that uses extracted gene-proteins from SF9 in a cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 384-well plate.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "SF9", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 5, + "geneName": "acid phosphatase 1, soluble", + "description": null, + "geneSymbol": "ACP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 52, + "officialSymbol": "ACP1", + "officialFullName": "acid phosphatase 1, soluble", + "uniprotAccessionNumber": "P24666" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 385, + "assayComponentEndpointName": "NVS_ENZ_hAKT1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hAKT1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hAKT1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene AKT1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 234, + "assayComponentName": "NVS_ENZ_hAKT1", + "assayComponentDesc": "NVS_ENZ_hAKT1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hAKT1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human v-akt murine thymoma viral oncogene homolog 1 [GeneSymbol:AKT1 | GeneID:207 | Uniprot_SwissProt_Accession:P31749].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 48, + "assayName": "NVS_ENZ_hAKT1", + "assayDesc": "NVS_ENZ_hAKT1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 22, + "geneName": "v-akt murine thymoma viral oncogene homolog 1", + "description": null, + "geneSymbol": "AKT1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 207, + "officialSymbol": "AKT1", + "officialFullName": "v-akt murine thymoma viral oncogene homolog 1", + "uniprotAccessionNumber": "P31749" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 387, + "assayComponentEndpointName": "NVS_ENZ_hAKT2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hAKT2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hAKT2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene AKT2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 235, + "assayComponentName": "NVS_ENZ_hAKT2", + "assayComponentDesc": "NVS_ENZ_hAKT2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hAKT2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human v-akt murine thymoma viral oncogene homolog 2 [GeneSymbol:AKT2 | GeneID:208 | Uniprot_SwissProt_Accession:P31751].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 49, + "assayName": "NVS_ENZ_hAKT2", + "assayDesc": "NVS_ENZ_hAKT2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 23, + "geneName": "v-akt murine thymoma viral oncogene homolog 2", + "description": null, + "geneSymbol": "AKT2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 208, + "officialSymbol": "AKT2", + "officialFullName": "v-akt murine thymoma viral oncogene homolog 2", + "uniprotAccessionNumber": "P31751" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 389, + "assayComponentEndpointName": "NVS_ENZ_hAKT3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hAKT3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hAKT3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene AKT3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 236, + "assayComponentName": "NVS_ENZ_hAKT3", + "assayComponentDesc": "NVS_ENZ_hAKT3 is one of one assay component(s) measured or calculated from the NVS_ENZ_hAKT3 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human v-akt murine thymoma viral oncogene homolog 3 [GeneSymbol:AKT3 | GeneID:10000 | Uniprot_SwissProt_Accession:Q9Y243].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 50, + "assayName": "NVS_ENZ_hAKT3", + "assayDesc": "NVS_ENZ_hAKT3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 359, + "geneName": "v-akt murine thymoma viral oncogene homolog 3", + "description": null, + "geneSymbol": "AKT3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10000, + "officialSymbol": "AKT3", + "officialFullName": "v-akt murine thymoma viral oncogene homolog 3", + "uniprotAccessionNumber": "Q9Y243" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 391, + "assayComponentEndpointName": "NVS_ENZ_hAMPKa1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hAMPKa1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hAMPKa1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PRKAA1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 237, + "assayComponentName": "NVS_ENZ_hAMPKa1", + "assayComponentDesc": "NVS_ENZ_hAMPKa1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hAMPKa1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human protein kinase, AMP-activated, alpha 1 catalytic subunit [GeneSymbol:PRKAA1 | GeneID:5562 | Uniprot_SwissProt_Accession:Q13131].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 51, + "assayName": "NVS_ENZ_hAMPKa1", + "assayDesc": "NVS_ENZ_hAMPKa1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 255, + "geneName": "protein kinase, AMP-activated, alpha 1 catalytic subunit", + "description": null, + "geneSymbol": "PRKAA1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5562, + "officialSymbol": "PRKAA1", + "officialFullName": "protein kinase, AMP-activated, alpha 1 catalytic subunit", + "uniprotAccessionNumber": "Q13131" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 393, + "assayComponentEndpointName": "NVS_ENZ_hAurA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hAurA was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hAurA, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene AURKA. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 238, + "assayComponentName": "NVS_ENZ_hAurA", + "assayComponentDesc": "NVS_ENZ_hAurA is one of one assay component(s) measured or calculated from the NVS_ENZ_hAurA assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human aurora kinase A [GeneSymbol:AURKA | GeneID:6790 | Uniprot_SwissProt_Accession:O14965].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 52, + "assayName": "NVS_ENZ_hAurA", + "assayDesc": "NVS_ENZ_hAurA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 306, + "geneName": "aurora kinase A", + "description": null, + "geneSymbol": "AURKA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 6790, + "officialSymbol": "AURKA", + "officialFullName": "aurora kinase A", + "uniprotAccessionNumber": "O14965" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 395, + "assayComponentEndpointName": "NVS_ENZ_hBACE", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hBACE was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hBACE, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene BACE1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is aspartate protease.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "OM99-02", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "aspartate protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 239, + "assayComponentName": "NVS_ENZ_hBACE", + "assayComponentDesc": "NVS_ENZ_hBACE is one of one assay component(s) measured or calculated from the NVS_ENZ_hBACE assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Rh-EVNLDAEFK-Quencher (weak fluorescence)+BACE --> Rh-ENVL(increased fluorescence) + DAEFK-Quencher] involving the key substrate [Rh-EVNLDAEFK-Quencher] are indicative of changes in enzyme function and kinetics for the human beta-site APP-cleaving enzyme 1 [GeneSymbol:BACE1 | GeneID:23621 | Uniprot_SwissProt_Accession:P56817].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Rh-EVNLDAEFK-Quencher", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 53, + "assayName": "NVS_ENZ_hBACE", + "assayDesc": "NVS_ENZ_hBACE is a biochemical, single-readout assay that uses extracted gene-proteins from SF9 in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "SF9", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 378, + "geneName": "beta-site APP-cleaving enzyme 1", + "description": null, + "geneSymbol": "BACE1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 23621, + "officialSymbol": "BACE1", + "officialFullName": "beta-site APP-cleaving enzyme 1", + "uniprotAccessionNumber": "P56817" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/10591214", + "pmid": 10591214, + "title": "Purification and cloning of amyloid precursor protein beta-secretase from human brain", + "author": "Sinha S, Anderson JP, Barbour R, Basi GS, Caccavello R, Davis D, Doan M, Dovey HF, Frigon N, Hong J, Jacobson-Croak K, Jewett N, Keim P, Knops J, Lieberburg I, Power M, Tan H, Tatsuno G, Tung J, Schenk D, Seubert P, Suomensaari SM, Wang S, Walker D, Zhao J, McConlogue L, John V", + "citation": "Sinha S, Anderson JP, Barbour R, Basi GS, Caccavello R, Davis D, Doan M, Dovey HF, Frigon N, Hong J, Jacobson-Croak K, Jewett N, Keim P, Knops J, Lieberburg I, Power M, Tan H, Tatsuno G, Tung J, Schenk D, Seubert P, Suomensaari SM, Wang S, Walker D, Zhao J, McConlogue L, John V. Purification and cloning of amyloid precursor protein beta-secretase from human brain. Nature. 1999 Dec 2;402(6761):537-40. PubMed PMID: 10591214.", + "otherId": "0", + "citationId": 180, + "otherSource": "" + } + }, + { + "aeid": 397, + "assayComponentEndpointName": "NVS_ENZ_hBTK", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hBTK was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hBTK, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene BTK. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 240, + "assayComponentName": "NVS_ENZ_hBTK", + "assayComponentDesc": "NVS_ENZ_hBTK is one of one assay component(s) measured or calculated from the NVS_ENZ_hBTK assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human Bruton agammaglobulinemia tyrosine kinase [GeneSymbol:BTK | GeneID:695 | Uniprot_SwissProt_Accession:Q06187].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 54, + "assayName": "NVS_ENZ_hBTK", + "assayDesc": "NVS_ENZ_hBTK is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 36, + "geneName": "Bruton agammaglobulinemia tyrosine kinase", + "description": null, + "geneSymbol": "BTK", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 695, + "officialSymbol": "BTK", + "officialFullName": "Bruton agammaglobulinemia tyrosine kinase", + "uniprotAccessionNumber": "Q06187" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 399, + "assayComponentEndpointName": "NVS_ENZ_hCASP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCASP1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCASP1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CASP1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is cysteine protease.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ac-YVAD-CHO", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "cysteine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 241, + "assayComponentName": "NVS_ENZ_hCASP1", + "assayComponentDesc": "NVS_ENZ_hCASP1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hCASP1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:LEHD-AFC --> LEHD+ AFC(fluorescent)] involving the key substrate [7-amino-4-trifluoromethylcoumarin-tagged LEHD] are indicative of changes in enzyme function and kinetics for the human caspase 1, apoptosis-related cysteine peptidase [GeneSymbol:CASP1 | GeneID:834 | Uniprot_SwissProt_Accession:P29466].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-amino-4-trifluoromethylcoumarin-tagged LEHD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 55, + "assayName": "NVS_ENZ_hCASP1", + "assayDesc": "NVS_ENZ_hCASP1 is a biochemical, single-readout assay that uses extracted gene-proteins from E. coli in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 39, + "geneName": "caspase 1, apoptosis-related cysteine peptidase", + "description": null, + "geneSymbol": "CASP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 834, + "officialSymbol": "CASP1", + "officialFullName": "caspase 1, apoptosis-related cysteine peptidase", + "uniprotAccessionNumber": "P29466" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/9092497", + "pmid": 9092497, + "title": "Substrate specificities of caspase family proteases", + "author": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW", + "citation": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW. Substrate specificities of caspase family proteases. J Biol Chem. 1997 Apr 11;272(15):9677-82. PubMed PMID: 9092497.", + "otherId": "0", + "citationId": 170, + "otherSource": "" + } + }, + { + "aeid": 401, + "assayComponentEndpointName": "NVS_ENZ_hCASP10", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCASP10 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCASP10, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CASP10. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is cysteine protease.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ac-DEVD-CHO", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "cysteine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 242, + "assayComponentName": "NVS_ENZ_hCASP10", + "assayComponentDesc": "NVS_ENZ_hCASP10 is one of one assay component(s) measured or calculated from the NVS_ENZ_hCASP10 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:LEHD-AFC --> LEHD+ AFC(fluorescent)] involving the key substrate [7-amino-4-trifluoromethylcoumarin-tagged LEHD] are indicative of changes in enzyme function and kinetics for the human caspase 10, apoptosis-related cysteine peptidase [GeneSymbol:CASP10 | GeneID:843 | Uniprot_SwissProt_Accession:Q92851].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-amino-4-trifluoromethylcoumarin-tagged LEHD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 56, + "assayName": "NVS_ENZ_hCASP10", + "assayDesc": "NVS_ENZ_hCASP10 is a biochemical, single-readout assay that uses extracted gene-proteins from E. coli in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 45, + "geneName": "caspase 10, apoptosis-related cysteine peptidase", + "description": null, + "geneSymbol": "CASP10", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 843, + "officialSymbol": "CASP10", + "officialFullName": "caspase 10, apoptosis-related cysteine peptidase", + "uniprotAccessionNumber": "Q92851" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/9092497", + "pmid": 9092497, + "title": "Substrate specificities of caspase family proteases", + "author": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW", + "citation": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW. Substrate specificities of caspase family proteases. J Biol Chem. 1997 Apr 11;272(15):9677-82. PubMed PMID: 9092497.", + "otherId": "0", + "citationId": 170, + "otherSource": "" + } + }, + { + "aeid": 403, + "assayComponentEndpointName": "NVS_ENZ_hCASP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCASP2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCASP2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CASP2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is cysteine protease.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "z-VDVAD-CHO", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "cysteine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 243, + "assayComponentName": "NVS_ENZ_hCASP2", + "assayComponentDesc": "NVS_ENZ_hCASP2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hCASP2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:VDVAD-AFC --> VDVAD + AFC] involving the key substrate [7-amino-4-trifluoromethylcoumarin-tagged VDVAD] are indicative of changes in enzyme function and kinetics for the human caspase 2, apoptosis-related cysteine peptidase [GeneSymbol:CASP2 | GeneID:835 | Uniprot_SwissProt_Accession:P42575].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-amino-4-trifluoromethylcoumarin-tagged VDVAD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 57, + "assayName": "NVS_ENZ_hCASP2", + "assayDesc": "NVS_ENZ_hCASP2 is a biochemical, single-readout assay that uses extracted gene-proteins from E. coli in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 40, + "geneName": "caspase 2, apoptosis-related cysteine peptidase", + "description": null, + "geneSymbol": "CASP2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 835, + "officialSymbol": "CASP2", + "officialFullName": "caspase 2, apoptosis-related cysteine peptidase", + "uniprotAccessionNumber": "P42575" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/9092497", + "pmid": 9092497, + "title": "Substrate specificities of caspase family proteases", + "author": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW", + "citation": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW. Substrate specificities of caspase family proteases. J Biol Chem. 1997 Apr 11;272(15):9677-82. PubMed PMID: 9092497.", + "otherId": "0", + "citationId": 170, + "otherSource": "" + } + }, + { + "aeid": 405, + "assayComponentEndpointName": "NVS_ENZ_hCASP3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCASP3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCASP3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CASP3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is cysteine protease.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ac-DEVD-CHO", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "cysteine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 244, + "assayComponentName": "NVS_ENZ_hCASP3", + "assayComponentDesc": "NVS_ENZ_hCASP3 is one of one assay component(s) measured or calculated from the NVS_ENZ_hCASP3 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:DEVD-AFC --> DEVD + AFC] involving the key substrate [7-amino-4-trifluoromethylcoumarin-tagged DEVD] are indicative of changes in enzyme function and kinetics for the human caspase 3, apoptosis-related cysteine peptidase [GeneSymbol:CASP3 | GeneID:836 | Uniprot_SwissProt_Accession:P42574].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-amino-4-trifluoromethylcoumarin-tagged DEVD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 58, + "assayName": "NVS_ENZ_hCASP3", + "assayDesc": "NVS_ENZ_hCASP3 is a biochemical, single-readout assay that uses extracted gene-proteins from E. coli in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 41, + "geneName": "caspase 3, apoptosis-related cysteine peptidase", + "description": null, + "geneSymbol": "CASP3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 836, + "officialSymbol": "CASP3", + "officialFullName": "caspase 3, apoptosis-related cysteine peptidase", + "uniprotAccessionNumber": "P42574" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/9092497", + "pmid": 9092497, + "title": "Substrate specificities of caspase family proteases", + "author": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW", + "citation": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW. Substrate specificities of caspase family proteases. J Biol Chem. 1997 Apr 11;272(15):9677-82. PubMed PMID: 9092497.", + "otherId": "0", + "citationId": 170, + "otherSource": "" + } + }, + { + "aeid": 407, + "assayComponentEndpointName": "NVS_ENZ_hCASP4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCASP4 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCASP4, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CASP4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is cysteine protease.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ac-LEHD-CHO", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "cysteine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 245, + "assayComponentName": "NVS_ENZ_hCASP4", + "assayComponentDesc": "NVS_ENZ_hCASP4 is one of one assay component(s) measured or calculated from the NVS_ENZ_hCASP4 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:LEHD-AFC --> LEHD+ AFC(fluorescent)] involving the key substrate [7-amino-4-trifluoromethylcoumarin-tagged LEHD] are indicative of changes in enzyme function and kinetics for the human caspase 4, apoptosis-related cysteine peptidase [GeneSymbol:CASP4 | GeneID:837 | Uniprot_SwissProt_Accession:P49662].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-amino-4-trifluoromethylcoumarin-tagged LEHD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 59, + "assayName": "NVS_ENZ_hCASP4", + "assayDesc": "NVS_ENZ_hCASP4 is a biochemical, single-readout assay that uses extracted gene-proteins from E. coli in a cell-free assay. Measurements were taken 2 hours after chemical dosing in a 96-well plate.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 42, + "geneName": "caspase 4, apoptosis-related cysteine peptidase", + "description": null, + "geneSymbol": "CASP4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 837, + "officialSymbol": "CASP4", + "officialFullName": "caspase 4, apoptosis-related cysteine peptidase", + "uniprotAccessionNumber": "P49662" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/9092497", + "pmid": 9092497, + "title": "Substrate specificities of caspase family proteases", + "author": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW", + "citation": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW. Substrate specificities of caspase family proteases. J Biol Chem. 1997 Apr 11;272(15):9677-82. PubMed PMID: 9092497.", + "otherId": "0", + "citationId": 170, + "otherSource": "" + } + }, + { + "aeid": 409, + "assayComponentEndpointName": "NVS_ENZ_hCASP5", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCASP5 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCASP5, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CASP5. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is cysteine protease.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ac-LEHD-CHO", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "cysteine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 246, + "assayComponentName": "NVS_ENZ_hCASP5", + "assayComponentDesc": "NVS_ENZ_hCASP5 is one of one assay component(s) measured or calculated from the NVS_ENZ_hCASP5 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:LEHD-AFC --> LEHD+ AFC(fluorescent)] involving the key substrate [7-amino-4-trifluoromethylcoumarin-tagged LEHD] are indicative of changes in enzyme function and kinetics for the human caspase 5, apoptosis-related cysteine peptidase [GeneSymbol:CASP5 | GeneID:838 | Uniprot_SwissProt_Accession:P51878].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-amino-4-trifluoromethylcoumarin-tagged LEHD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 60, + "assayName": "NVS_ENZ_hCASP5", + "assayDesc": "NVS_ENZ_hCASP5 is a biochemical, single-readout assay that uses extracted gene-proteins from E. coli in a cell-free assay. Measurements were taken 2 hours after chemical dosing in a 96-well plate.", + "timepointHr": 2.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 43, + "geneName": "caspase 5, apoptosis-related cysteine peptidase", + "description": null, + "geneSymbol": "CASP5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 838, + "officialSymbol": "CASP5", + "officialFullName": "caspase 5, apoptosis-related cysteine peptidase", + "uniprotAccessionNumber": "P51878" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/9092497", + "pmid": 9092497, + "title": "Substrate specificities of caspase family proteases", + "author": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW", + "citation": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW. Substrate specificities of caspase family proteases. J Biol Chem. 1997 Apr 11;272(15):9677-82. PubMed PMID: 9092497.", + "otherId": "0", + "citationId": 170, + "otherSource": "" + } + }, + { + "aeid": 411, + "assayComponentEndpointName": "NVS_ENZ_hCASP8", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCASP8 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCASP8, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CASP8. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is cysteine protease.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ac-DEVD-CHO", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "cysteine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 247, + "assayComponentName": "NVS_ENZ_hCASP8", + "assayComponentDesc": "NVS_ENZ_hCASP8 is one of one assay component(s) measured or calculated from the NVS_ENZ_hCASP8 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:LEHD-AFC --> LEHD+ AFC(fluorescent)] involving the key substrate [7-amino-4-trifluoromethylcoumarin-tagged LEHD] are indicative of changes in enzyme function and kinetics for the human caspase 8, apoptosis-related cysteine peptidase [GeneSymbol:CASP8 | GeneID:841 | Uniprot_SwissProt_Accession:Q14790].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "7-amino-4-trifluoromethylcoumarin-tagged LEHD", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 61, + "assayName": "NVS_ENZ_hCASP8", + "assayDesc": "NVS_ENZ_hCASP8 is a biochemical, single-readout assay that uses extracted gene-proteins from E. coli in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "E. coli", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 44, + "geneName": "caspase 8, apoptosis-related cysteine peptidase", + "description": null, + "geneSymbol": "CASP8", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 841, + "officialSymbol": "CASP8", + "officialFullName": "caspase 8, apoptosis-related cysteine peptidase", + "uniprotAccessionNumber": "Q14790" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/9092497", + "pmid": 9092497, + "title": "Substrate specificities of caspase family proteases", + "author": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW", + "citation": "Talanian RV, Quinlan C, Trautz S, Hackett MC, Mankovich JA, Banach D, Ghayur T, Brady KD, Wong WW. Substrate specificities of caspase family proteases. J Biol Chem. 1997 Apr 11;272(15):9677-82. PubMed PMID: 9092497.", + "otherId": "0", + "citationId": 170, + "otherSource": "" + } + }, + { + "aeid": 413, + "assayComponentEndpointName": "NVS_ENZ_hCDK2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCDK2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCDK2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CDK2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 248, + "assayComponentName": "NVS_ENZ_hCDK2", + "assayComponentDesc": "NVS_ENZ_hCDK2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hCDK2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human cyclin-dependent kinase 2 [GeneSymbol:CDK2 | GeneID:1017 | Uniprot_SwissProt_Accession:P24941].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 62, + "assayName": "NVS_ENZ_hCDK2", + "assayDesc": "NVS_ENZ_hCDK2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 55, + "geneName": "cyclin-dependent kinase 2", + "description": null, + "geneSymbol": "CDK2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1017, + "officialSymbol": "CDK2", + "officialFullName": "cyclin-dependent kinase 2", + "uniprotAccessionNumber": "P24941" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 415, + "assayComponentEndpointName": "NVS_ENZ_hCDK6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCDK6 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCDK6, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CDK6. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 249, + "assayComponentName": "NVS_ENZ_hCDK6", + "assayComponentDesc": "NVS_ENZ_hCDK6 is one of one assay component(s) measured or calculated from the NVS_ENZ_hCDK6 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human cyclin-dependent kinase 6 [GeneSymbol:CDK6 | GeneID:1021 | Uniprot_SwissProt_Accession:Q00534].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 63, + "assayName": "NVS_ENZ_hCDK6", + "assayDesc": "NVS_ENZ_hCDK6 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 56, + "geneName": "cyclin-dependent kinase 6", + "description": null, + "geneSymbol": "CDK6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1021, + "officialSymbol": "CDK6", + "officialFullName": "cyclin-dependent kinase 6", + "uniprotAccessionNumber": "Q00534" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 417, + "assayComponentEndpointName": "NVS_ENZ_hCHK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCHK1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCHK1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CHEK1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 250, + "assayComponentName": "NVS_ENZ_hCHK1", + "assayComponentDesc": "NVS_ENZ_hCHK1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hCHK1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human checkpoint kinase 1 [GeneSymbol:CHEK1 | GeneID:1111 | Uniprot_SwissProt_Accession:O14757].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 64, + "assayName": "NVS_ENZ_hCHK1", + "assayDesc": "NVS_ENZ_hCHK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 60, + "geneName": "checkpoint kinase 1", + "description": null, + "geneSymbol": "CHEK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1111, + "officialSymbol": "CHEK1", + "officialFullName": "checkpoint kinase 1", + "uniprotAccessionNumber": "O14757" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 419, + "assayComponentEndpointName": "NVS_ENZ_hCK1a", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCK1a was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCK1a, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CSNK1A1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "5-iodotubericidin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 251, + "assayComponentName": "NVS_ENZ_hCK1a", + "assayComponentDesc": "NVS_ENZ_hCK1a is one of one assay component(s) measured or calculated from the NVS_ENZ_hCK1a assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human casein kinase 1, alpha 1 [GeneSymbol:CSNK1A1 | GeneID:1452 | Uniprot_SwissProt_Accession:P48729].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 65, + "assayName": "NVS_ENZ_hCK1a", + "assayDesc": "NVS_ENZ_hCK1a is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 74, + "geneName": "casein kinase 1, alpha 1", + "description": null, + "geneSymbol": "CSNK1A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1452, + "officialSymbol": "CSNK1A1", + "officialFullName": "casein kinase 1, alpha 1", + "uniprotAccessionNumber": "P48729" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 421, + "assayComponentEndpointName": "NVS_ENZ_hCK1D", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCK1D was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCK1D, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CSNK1D. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "5-iodotubericidin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 252, + "assayComponentName": "NVS_ENZ_hCK1D", + "assayComponentDesc": "NVS_ENZ_hCK1D is one of one assay component(s) measured or calculated from the NVS_ENZ_hCK1D assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human casein kinase 1, delta [GeneSymbol:CSNK1D | GeneID:1453 | Uniprot_SwissProt_Accession:P48730].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 66, + "assayName": "NVS_ENZ_hCK1D", + "assayDesc": "NVS_ENZ_hCK1D is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 75, + "geneName": "casein kinase 1, delta", + "description": null, + "geneSymbol": "CSNK1D", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1453, + "officialSymbol": "CSNK1D", + "officialFullName": "casein kinase 1, delta", + "uniprotAccessionNumber": "P48730" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 423, + "assayComponentEndpointName": "NVS_ENZ_hCK2a2b2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCK2a2b2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCK2a2b2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CSNK2A1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 253, + "assayComponentName": "NVS_ENZ_hCK2a2b2", + "assayComponentDesc": "NVS_ENZ_hCK2a2b2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hCK2a2b2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human casein kinase 2, alpha 1 polypeptide [GeneSymbol:CSNK2A1 | GeneID:1457 | Uniprot_SwissProt_Accession:Q8NEV1].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 67, + "assayName": "NVS_ENZ_hCK2a2b2", + "assayDesc": "NVS_ENZ_hCK2a2b2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 76, + "geneName": "casein kinase 2, alpha 1 polypeptide", + "description": null, + "geneSymbol": "CSNK2A1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1457, + "officialSymbol": "CSNK2A1", + "officialFullName": "casein kinase 2, alpha 1 polypeptide", + "uniprotAccessionNumber": "Q8NEV1" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 425, + "assayComponentEndpointName": "NVS_ENZ_hCSF1R", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hCSF1R was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hCSF1R, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CSF1R. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 254, + "assayComponentName": "NVS_ENZ_hCSF1R", + "assayComponentDesc": "NVS_ENZ_hCSF1R is one of one assay component(s) measured or calculated from the NVS_ENZ_hCSF1R assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human colony stimulating factor 1 receptor [GeneSymbol:CSF1R | GeneID:1436 | Uniprot_SwissProt_Accession:P07333].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 68, + "assayName": "NVS_ENZ_hCSF1R", + "assayDesc": "NVS_ENZ_hCSF1R is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 73, + "geneName": "colony stimulating factor 1 receptor", + "description": null, + "geneSymbol": "CSF1R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1436, + "officialSymbol": "CSF1R", + "officialFullName": "colony stimulating factor 1 receptor", + "uniprotAccessionNumber": "P07333" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 427, + "assayComponentEndpointName": "NVS_ENZ_hDUSP3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hDUSP3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hDUSP3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene DUSP3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the phosphatase intended target family, where the subfamily is dual-specific phosphatase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ammonium Molybdate (NH4MoO4)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "phosphatase", + "intendedTargetFamilySub": "dual-specific phosphatase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 255, + "assayComponentName": "NVS_ENZ_hDUSP3", + "assayComponentDesc": "NVS_ENZ_hDUSP3 is one of one assay component(s) measured or calculated from the NVS_ENZ_hDUSP3 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:DiFMUP(non-fluorescent) --> DiFMU] involving the key substrate [6,8-difluoro-4-methylumbelliferyl] are indicative of changes in enzyme function and kinetics for the human dual specificity phosphatase 3 [GeneSymbol:DUSP3 | GeneID:1845 | Uniprot_SwissProt_Accession:P51452].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "6,8-difluoro-4-methylumbelliferyl", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 69, + "assayName": "NVS_ENZ_hDUSP3", + "assayDesc": "NVS_ENZ_hDUSP3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 102, + "geneName": "dual specificity phosphatase 3", + "description": null, + "geneSymbol": "DUSP3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1845, + "officialSymbol": "DUSP3", + "officialFullName": "dual specificity phosphatase 3", + "uniprotAccessionNumber": "P51452" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/7852302", + "pmid": 7852302, + "title": "Insulin receptor signaling is augmented by antisense inhibition of the protein tyrosine phosphatase LAR", + "author": "Kulas DT, Zhang WR, Goldstein BJ, Furlanetto RW, Mooney RA", + "citation": "Kulas DT, Zhang WR, Goldstein BJ, Furlanetto RW, Mooney RA. Insulin receptor signaling is augmented by antisense inhibition of the protein tyrosine phosphatase LAR. J Biol Chem. 1995 Feb 10;270(6):2435-8. PubMed PMID: 7852302.", + "otherId": "0", + "citationId": 147, + "otherSource": "" + } + }, + { + "aeid": 429, + "assayComponentEndpointName": "NVS_ENZ_hEGFR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hEGFR was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hEGFR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene EGFR. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 256, + "assayComponentName": "NVS_ENZ_hEGFR", + "assayComponentDesc": "NVS_ENZ_hEGFR is one of one assay component(s) measured or calculated from the NVS_ENZ_hEGFR assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human epidermal growth factor receptor [GeneSymbol:EGFR | GeneID:1956 | Uniprot_SwissProt_Accession:P00533].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 70, + "assayName": "NVS_ENZ_hEGFR", + "assayDesc": "NVS_ENZ_hEGFR is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 108, + "geneName": "epidermal growth factor receptor", + "description": null, + "geneSymbol": "EGFR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1956, + "officialSymbol": "EGFR", + "officialFullName": "epidermal growth factor receptor", + "uniprotAccessionNumber": "P00533" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 431, + "assayComponentEndpointName": "NVS_ENZ_hElastase", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hElastase was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hElastase, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene ELANE. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is serine protease.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Ursolic acid", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "serine protease", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 257, + "assayComponentName": "NVS_ENZ_hElastase", + "assayComponentDesc": "NVS_ENZ_hElastase is one of one assay component(s) measured or calculated from the NVS_ENZ_hElastase assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by Spectrophotometry technology.", + "assayComponentTargetDesc": "Changes to absorbance signals produced from an enzymatic reaction involving the key substrate [MeO-Suc-Ala-Ala-Pro-Val-p-Nitroanilide] are indicative of changes in enzyme function and kinetics for the human elastase, neutrophil expressed [GeneSymbol:ELANE | GeneID:1991 | Uniprot_SwissProt_Accession:P08246].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Absorbance", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "MeO-Suc-Ala-Ala-Pro-Val-p-Nitroanilide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 71, + "assayName": "NVS_ENZ_hElastase", + "assayDesc": "NVS_ENZ_hElastase is a biochemical, single-readout assay that uses extracted gene-proteins from Human neutrophils in a cell-free assay. Measurements were taken 1.5 hours after chemical dosing in a 96-well plate.", + "timepointHr": 1.5, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "Human neutrophils", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 111, + "geneName": "elastase, neutrophil expressed", + "description": null, + "geneSymbol": "ELANE", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1991, + "officialSymbol": "ELANE", + "officialFullName": "elastase, neutrophil expressed", + "uniprotAccessionNumber": "P08246" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/9103531", + "pmid": 9103531, + "title": "Inhibition by boswellic acids of human leukocyte elastase", + "author": "Safayhi H, Rall B, Sailer ER, Ammon HP", + "citation": "Safayhi H, Rall B, Sailer ER, Ammon HP. Inhibition by boswellic acids of human leukocyte elastase. J Pharmacol Exp Ther. 1997 Apr;281(1):460-3. PubMed PMID: 9103531.", + "otherId": "0", + "citationId": 171, + "otherSource": "" + } + }, + { + "aeid": 433, + "assayComponentEndpointName": "NVS_ENZ_hEphA1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hEphA1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hEphA1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene EPHA1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 258, + "assayComponentName": "NVS_ENZ_hEphA1", + "assayComponentDesc": "NVS_ENZ_hEphA1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hEphA1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human EPH receptor A1 [GeneSymbol:EPHA1 | GeneID:2041 | Uniprot_SwissProt_Accession:P21709].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 72, + "assayName": "NVS_ENZ_hEphA1", + "assayDesc": "NVS_ENZ_hEphA1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 113, + "geneName": "EPH receptor A1", + "description": null, + "geneSymbol": "EPHA1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2041, + "officialSymbol": "EPHA1", + "officialFullName": "EPH receptor A1", + "uniprotAccessionNumber": "P21709" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 435, + "assayComponentEndpointName": "NVS_ENZ_hEphA2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hEphA2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hEphA2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene EPHA2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 259, + "assayComponentName": "NVS_ENZ_hEphA2", + "assayComponentDesc": "NVS_ENZ_hEphA2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hEphA2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human EPH receptor A2 [GeneSymbol:EPHA2 | GeneID:1969 | Uniprot_SwissProt_Accession:P29317].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 73, + "assayName": "NVS_ENZ_hEphA2", + "assayDesc": "NVS_ENZ_hEphA2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 110, + "geneName": "EPH receptor A2", + "description": null, + "geneSymbol": "EPHA2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1969, + "officialSymbol": "EPHA2", + "officialFullName": "EPH receptor A2", + "uniprotAccessionNumber": "P29317" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 437, + "assayComponentEndpointName": "NVS_ENZ_hEphB1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hEphB1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hEphB1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene EPHB1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 260, + "assayComponentName": "NVS_ENZ_hEphB1", + "assayComponentDesc": "NVS_ENZ_hEphB1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hEphB1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human EPH receptor B1 [GeneSymbol:EPHB1 | GeneID:2047 | Uniprot_SwissProt_Accession:P54762].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 74, + "assayName": "NVS_ENZ_hEphB1", + "assayDesc": "NVS_ENZ_hEphB1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 114, + "geneName": "EPH receptor B1", + "description": null, + "geneSymbol": "EPHB1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2047, + "officialSymbol": "EPHB1", + "officialFullName": "EPH receptor B1", + "uniprotAccessionNumber": "P54762" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 439, + "assayComponentEndpointName": "NVS_ENZ_hEphB2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hEphB2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hEphB2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene EPHB2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 261, + "assayComponentName": "NVS_ENZ_hEphB2", + "assayComponentDesc": "NVS_ENZ_hEphB2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hEphB2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human EPH receptor B2 [GeneSymbol:EPHB2 | GeneID:2048 | Uniprot_SwissProt_Accession:P29323].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 75, + "assayName": "NVS_ENZ_hEphB2", + "assayDesc": "NVS_ENZ_hEphB2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 115, + "geneName": "EPH receptor B2", + "description": null, + "geneSymbol": "EPHB2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2048, + "officialSymbol": "EPHB2", + "officialFullName": "EPH receptor B2", + "uniprotAccessionNumber": "P29323" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 441, + "assayComponentEndpointName": "NVS_ENZ_hES", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hES was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hES, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene BCHE. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is pseudocholinesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "physostigmine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "pseudocholinesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 262, + "assayComponentName": "NVS_ENZ_hES", + "assayComponentDesc": "NVS_ENZ_hES is one of one assay component(s) measured or calculated from the NVS_ENZ_hES assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with absorbance signals by Colorimetric technology.", + "assayComponentTargetDesc": "Changes to absorbance signals are produced from enzymatic reactions [Reaction:Acetylthiocholine-->Acetate +Thiocholine | Thiocholine + DTNB (Ellman\"s Reagent)--> 5-thio-2-nitrobenzoic acid (yellow)] involving the key substrates [acetylthiocholine and Ellman\"s reagent (DTNB)]. These indicate changes to the enzyme function for the human butyrylcholinesterase [GeneSymbol:BCHE | GeneID:590 | Uniprot_SwissProt_Accession:P06276].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Absorbance ", + "detectionTechnologyTypeSub": "Colorimetric", + "detectionTechnology": "Spectrophotometry", + "keyAssayReagentType": "substrate;substrate", + "keyAssayReagent": "acetylthiocholine;Ellman\"s reagent (DTNB)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 76, + "assayName": "NVS_ENZ_hES", + "assayDesc": "NVS_ENZ_hES is a biochemical, single-readout assay that uses extracted gene-proteins from Human plasma in a cell-free assay. Measurements were taken 0.25 hour after chemical dosing in a 96-well plate.", + "timepointHr": 0.25, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "Human plasma", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 32, + "geneName": "butyrylcholinesterase", + "description": null, + "geneSymbol": "BCHE", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 590, + "officialSymbol": "BCHE", + "officialFullName": "butyrylcholinesterase", + "uniprotAccessionNumber": "P06276" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/13726518", + "pmid": 13726518, + "title": "A new and rapid colorimetric determination of acetylcholinesterase activity", + "author": "ELLMAN GL, COURTNEY KD, ANDRES V Jr, FEATHER-STONE RM", + "citation": "ELLMAN GL, COURTNEY KD, ANDRES V Jr, FEATHER-STONE RM. A new and rapid colorimetric determination of acetylcholinesterase activity. Biochem Pharmacol. 1961 Jul;7:88-95. PubMed PMID: 13726518.", + "otherId": "0", + "citationId": 197, + "otherSource": "" + } + }, + { + "aeid": 443, + "assayComponentEndpointName": "NVS_ENZ_hFGFR1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hFGFR1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hFGFR1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene FGFR1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "K252a", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 263, + "assayComponentName": "NVS_ENZ_hFGFR1", + "assayComponentDesc": "NVS_ENZ_hFGFR1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hFGFR1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human fibroblast growth factor receptor 1 [GeneSymbol:FGFR1 | GeneID:2260 | Uniprot_SwissProt_Accession:P11362].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 77, + "assayName": "NVS_ENZ_hFGFR1", + "assayDesc": "NVS_ENZ_hFGFR1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 126, + "geneName": "fibroblast growth factor receptor 1", + "description": null, + "geneSymbol": "FGFR1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2260, + "officialSymbol": "FGFR1", + "officialFullName": "fibroblast growth factor receptor 1", + "uniprotAccessionNumber": "P11362" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 445, + "assayComponentEndpointName": "NVS_ENZ_hFGFR3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hFGFR3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hFGFR3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene FGFR3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 264, + "assayComponentName": "NVS_ENZ_hFGFR3", + "assayComponentDesc": "NVS_ENZ_hFGFR3 is one of one assay component(s) measured or calculated from the NVS_ENZ_hFGFR3 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human fibroblast growth factor receptor 3 [GeneSymbol:FGFR3 | GeneID:2261 | Uniprot_SwissProt_Accession:P22607].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 78, + "assayName": "NVS_ENZ_hFGFR3", + "assayDesc": "NVS_ENZ_hFGFR3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 127, + "geneName": "fibroblast growth factor receptor 3", + "description": null, + "geneSymbol": "FGFR3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2261, + "officialSymbol": "FGFR3", + "officialFullName": "fibroblast growth factor receptor 3", + "uniprotAccessionNumber": "P22607" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 447, + "assayComponentEndpointName": "NVS_ENZ_hFyn", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hFyn was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hFyn, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene FYN. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 265, + "assayComponentName": "NVS_ENZ_hFyn", + "assayComponentDesc": "NVS_ENZ_hFyn is one of one assay component(s) measured or calculated from the NVS_ENZ_hFyn assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human FYN proto-oncogene, Src family tyrosine kinase [GeneSymbol:FYN | GeneID:2534 | Uniprot_SwissProt_Accession:P06241].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 79, + "assayName": "NVS_ENZ_hFyn", + "assayDesc": "NVS_ENZ_hFyn is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 137, + "geneName": "FYN proto-oncogene, Src family tyrosine kinase", + "description": null, + "geneSymbol": "FYN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2534, + "officialSymbol": "FYN", + "officialFullName": "FYN proto-oncogene, Src family tyrosine kinase", + "uniprotAccessionNumber": "P06241" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 449, + "assayComponentEndpointName": "NVS_ENZ_hGSK3b", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hGSK3b was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hGSK3b, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene GSK3B. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 266, + "assayComponentName": "NVS_ENZ_hGSK3b", + "assayComponentDesc": "NVS_ENZ_hGSK3b is one of one assay component(s) measured or calculated from the NVS_ENZ_hGSK3b assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human glycogen synthase kinase 3 beta [GeneSymbol:GSK3B | GeneID:2932 | Uniprot_SwissProt_Accession:P49841].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 80, + "assayName": "NVS_ENZ_hGSK3b", + "assayDesc": "NVS_ENZ_hGSK3b is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 146, + "geneName": "glycogen synthase kinase 3 beta", + "description": null, + "geneSymbol": "GSK3B", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 2932, + "officialSymbol": "GSK3B", + "officialFullName": "glycogen synthase kinase 3 beta", + "uniprotAccessionNumber": "P49841" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 451, + "assayComponentEndpointName": "NVS_ENZ_hHDAC3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hHDAC3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hHDAC3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene HDAC3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the hydrolase intended target family, where the subfamily is histone deacetylase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "trichostatin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "hydrolase", + "intendedTargetFamilySub": "histone deacetylase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 267, + "assayComponentName": "NVS_ENZ_hHDAC3", + "assayComponentDesc": "NVS_ENZ_hHDAC3 is one of one assay component(s) measured or calculated from the NVS_ENZ_hHDAC3 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein - Acetylated peptide substrate --> Deacetylated peptide product] involving the key substrate [Fluorescein-labeled acetylated-peptide] are indicative of changes in enzyme function and kinetics for the human histone deacetylase 3 [GeneSymbol:HDAC3 | GeneID:8841 | Uniprot_SwissProt_Accession:O15379].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled acetylated-peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 81, + "assayName": "NVS_ENZ_hHDAC3", + "assayDesc": "NVS_ENZ_hHDAC3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 349, + "geneName": "histone deacetylase 3", + "description": null, + "geneSymbol": "HDAC3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8841, + "officialSymbol": "HDAC3", + "officialFullName": "histone deacetylase 3", + "uniprotAccessionNumber": "O15379" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 453, + "assayComponentEndpointName": "NVS_ENZ_hHDAC6", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hHDAC6 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hHDAC6, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene HDAC6. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the hydrolase intended target family, where the subfamily is histone deacetylase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "trichostatin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "hydrolase", + "intendedTargetFamilySub": "histone deacetylase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 268, + "assayComponentName": "NVS_ENZ_hHDAC6", + "assayComponentDesc": "NVS_ENZ_hHDAC6 is one of one assay component(s) measured or calculated from the NVS_ENZ_hHDAC6 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein - Acetylated peptide substrate --> Deacetylated peptide product] involving the key substrate [Fluorescein-labeled acetylated-peptide] are indicative of changes in enzyme function and kinetics for the human histone deacetylase 6 [GeneSymbol:HDAC6 | GeneID:10013 | Uniprot_SwissProt_Accession:Q9UBN7].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled acetylated-peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 82, + "assayName": "NVS_ENZ_hHDAC6", + "assayDesc": "NVS_ENZ_hHDAC6 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 361, + "geneName": "histone deacetylase 6", + "description": null, + "geneSymbol": "HDAC6", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10013, + "officialSymbol": "HDAC6", + "officialFullName": "histone deacetylase 6", + "uniprotAccessionNumber": "Q9UBN7" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 455, + "assayComponentEndpointName": "NVS_ENZ_hIGF1R", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hIGF1R was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hIGF1R, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene IGF1R. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 269, + "assayComponentName": "NVS_ENZ_hIGF1R", + "assayComponentDesc": "NVS_ENZ_hIGF1R is one of one assay component(s) measured or calculated from the NVS_ENZ_hIGF1R assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human insulin-like growth factor 1 receptor [GeneSymbol:IGF1R | GeneID:3480 | Uniprot_SwissProt_Accession:P08069].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 83, + "assayName": "NVS_ENZ_hIGF1R", + "assayDesc": "NVS_ENZ_hIGF1R is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 172, + "geneName": "insulin-like growth factor 1 receptor", + "description": null, + "geneSymbol": "IGF1R", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3480, + "officialSymbol": "IGF1R", + "officialFullName": "insulin-like growth factor 1 receptor", + "uniprotAccessionNumber": "P08069" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 457, + "assayComponentEndpointName": "NVS_ENZ_hIKKa", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hIKKa was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hIKKa, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene CHUK. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 270, + "assayComponentName": "NVS_ENZ_hIKKa", + "assayComponentDesc": "NVS_ENZ_hIKKa is one of one assay component(s) measured or calculated from the NVS_ENZ_hIKKa assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human conserved helix-loop-helix ubiquitous kinase [GeneSymbol:CHUK | GeneID:1147 | Uniprot_SwissProt_Accession:O15111].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 84, + "assayName": "NVS_ENZ_hIKKa", + "assayDesc": "NVS_ENZ_hIKKa is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 67, + "geneName": "conserved helix-loop-helix ubiquitous kinase", + "description": null, + "geneSymbol": "CHUK", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 1147, + "officialSymbol": "CHUK", + "officialFullName": "conserved helix-loop-helix ubiquitous kinase", + "uniprotAccessionNumber": "O15111" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 459, + "assayComponentEndpointName": "NVS_ENZ_hInsR", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hInsR was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hInsR, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene INSR. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 271, + "assayComponentName": "NVS_ENZ_hInsR", + "assayComponentDesc": "NVS_ENZ_hInsR is one of one assay component(s) measured or calculated from the NVS_ENZ_hInsR assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human insulin receptor [GeneSymbol:INSR | GeneID:3643 | Uniprot_SwissProt_Accession:P06213].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 85, + "assayName": "NVS_ENZ_hInsR", + "assayDesc": "NVS_ENZ_hInsR is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 179, + "geneName": "insulin receptor", + "description": null, + "geneSymbol": "INSR", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3643, + "officialSymbol": "INSR", + "officialFullName": "insulin receptor", + "uniprotAccessionNumber": "P06213" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 461, + "assayComponentEndpointName": "NVS_ENZ_hIRAK4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hIRAK4 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hIRAK4, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene IRAK4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 272, + "assayComponentName": "NVS_ENZ_hIRAK4", + "assayComponentDesc": "NVS_ENZ_hIRAK4 is one of one assay component(s) measured or calculated from the NVS_ENZ_hIRAK4 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human interleukin-1 receptor-associated kinase 4 [GeneSymbol:IRAK4 | GeneID:51135 | Uniprot_SwissProt_Accession:Q9NWZ3].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 86, + "assayName": "NVS_ENZ_hIRAK4", + "assayDesc": "NVS_ENZ_hIRAK4 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 425, + "geneName": "interleukin-1 receptor-associated kinase 4", + "description": null, + "geneSymbol": "IRAK4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 51135, + "officialSymbol": "IRAK4", + "officialFullName": "interleukin-1 receptor-associated kinase 4", + "uniprotAccessionNumber": "Q9NWZ3" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 463, + "assayComponentEndpointName": "NVS_ENZ_hJak2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hJak2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hJak2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene JAK2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 273, + "assayComponentName": "NVS_ENZ_hJak2", + "assayComponentDesc": "NVS_ENZ_hJak2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hJak2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human Janus kinase 2 [GeneSymbol:JAK2 | GeneID:3717 | Uniprot_SwissProt_Accession:O60674].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 87, + "assayName": "NVS_ENZ_hJak2", + "assayDesc": "NVS_ENZ_hJak2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 182, + "geneName": "Janus kinase 2", + "description": null, + "geneSymbol": "JAK2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3717, + "officialSymbol": "JAK2", + "officialFullName": "Janus kinase 2", + "uniprotAccessionNumber": "O60674" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 465, + "assayComponentEndpointName": "NVS_ENZ_hJNK2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hJNK2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hJNK2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MAPK9. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "SB203580", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 274, + "assayComponentName": "NVS_ENZ_hJNK2", + "assayComponentDesc": "NVS_ENZ_hJNK2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hJNK2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human mitogen-activated protein kinase 9 [GeneSymbol:MAPK9 | GeneID:5601 | Uniprot_SwissProt_Accession:P45984].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 88, + "assayName": "NVS_ENZ_hJNK2", + "assayDesc": "NVS_ENZ_hJNK2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 262, + "geneName": "mitogen-activated protein kinase 9", + "description": null, + "geneSymbol": "MAPK9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5601, + "officialSymbol": "MAPK9", + "officialFullName": "mitogen-activated protein kinase 9", + "uniprotAccessionNumber": "P45984" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 467, + "assayComponentEndpointName": "NVS_ENZ_hLck", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hLck was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hLck, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene LCK. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 275, + "assayComponentName": "NVS_ENZ_hLck", + "assayComponentDesc": "NVS_ENZ_hLck is one of one assay component(s) measured or calculated from the NVS_ENZ_hLck assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human LCK proto-oncogene, Src family tyrosine kinase [GeneSymbol:LCK | GeneID:3932 | Uniprot_SwissProt_Accession:P06239].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 89, + "assayName": "NVS_ENZ_hLck", + "assayDesc": "NVS_ENZ_hLck is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 188, + "geneName": "LCK proto-oncogene, Src family tyrosine kinase", + "description": null, + "geneSymbol": "LCK", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 3932, + "officialSymbol": "LCK", + "officialFullName": "LCK proto-oncogene, Src family tyrosine kinase", + "uniprotAccessionNumber": "P06239" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 469, + "assayComponentEndpointName": "NVS_ENZ_hLynA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hLynA was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hLynA, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene LYN. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 276, + "assayComponentName": "NVS_ENZ_hLynA", + "assayComponentDesc": "NVS_ENZ_hLynA is one of one assay component(s) measured or calculated from the NVS_ENZ_hLynA assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human LYN proto-oncogene, Src family tyrosine kinase [GeneSymbol:LYN | GeneID:4067 | Uniprot_SwissProt_Accession:P07948].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 90, + "assayName": "NVS_ENZ_hLynA", + "assayDesc": "NVS_ENZ_hLynA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 195, + "geneName": "LYN proto-oncogene, Src family tyrosine kinase", + "description": null, + "geneSymbol": "LYN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4067, + "officialSymbol": "LYN", + "officialFullName": "LYN proto-oncogene, Src family tyrosine kinase", + "uniprotAccessionNumber": "P07948" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 471, + "assayComponentEndpointName": "NVS_ENZ_hLynB", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hLynB was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hLynB, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene LYN. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is non-receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "non-receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 277, + "assayComponentName": "NVS_ENZ_hLynB", + "assayComponentDesc": "NVS_ENZ_hLynB is one of one assay component(s) measured or calculated from the NVS_ENZ_hLynB assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human LYN proto-oncogene, Src family tyrosine kinase [GeneSymbol:LYN | GeneID:4067 | Uniprot_SwissProt_Accession:P07948].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 91, + "assayName": "NVS_ENZ_hLynB", + "assayDesc": "NVS_ENZ_hLynB is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 195, + "geneName": "LYN proto-oncogene, Src family tyrosine kinase", + "description": null, + "geneSymbol": "LYN", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4067, + "officialSymbol": "LYN", + "officialFullName": "LYN proto-oncogene, Src family tyrosine kinase", + "uniprotAccessionNumber": "P07948" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/8106508", + "pmid": 8106508, + "title": "Src family tyrosine kinase p53/56lyn, a serine kinase and Fc epsilon RI associate with alpha-galactosyl derivatives of ganglioside GD1b in rat basophilic leukemia RBL-2H3 cells", + "author": "Minoguchi K, Swaim WD, Berenstein EH, Siraganian RP", + "citation": "Minoguchi K, Swaim WD, Berenstein EH, Siraganian RP. Src family tyrosine kinase p53/56lyn, a serine kinase and Fc epsilon RI associate with alpha-galactosyl derivatives of ganglioside GD1b in rat basophilic leukemia RBL-2H3 cells. J Biol Chem. 1994 Feb 18;269(7):5249-54. PubMed PMID: 8106508.", + "otherId": "0", + "citationId": 157, + "otherSource": "" + } + }, + { + "aeid": 473, + "assayComponentEndpointName": "NVS_ENZ_hMAPK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMAPK1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMAPK1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MAPK1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "K252a", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 278, + "assayComponentName": "NVS_ENZ_hMAPK1", + "assayComponentDesc": "NVS_ENZ_hMAPK1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMAPK1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human mitogen-activated protein kinase 1 [GeneSymbol:MAPK1 | GeneID:5594 | Uniprot_SwissProt_Accession:P28482].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 92, + "assayName": "NVS_ENZ_hMAPK1", + "assayDesc": "NVS_ENZ_hMAPK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 259, + "geneName": "mitogen-activated protein kinase 1", + "description": null, + "geneSymbol": "MAPK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5594, + "officialSymbol": "MAPK1", + "officialFullName": "mitogen-activated protein kinase 1", + "uniprotAccessionNumber": "P28482" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 475, + "assayComponentEndpointName": "NVS_ENZ_hMAPK11", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMAPK11 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMAPK11, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MAPK11. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "SB203580", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 279, + "assayComponentName": "NVS_ENZ_hMAPK11", + "assayComponentDesc": "NVS_ENZ_hMAPK11 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMAPK11 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human mitogen-activated protein kinase 11 [GeneSymbol:MAPK11 | GeneID:5600 | Uniprot_SwissProt_Accession:Q15759].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 93, + "assayName": "NVS_ENZ_hMAPK11", + "assayDesc": "NVS_ENZ_hMAPK11 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 0 hour after chemical dosing in a 384-well plate.", + "timepointHr": 0.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 261, + "geneName": "mitogen-activated protein kinase 11", + "description": null, + "geneSymbol": "MAPK11", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5600, + "officialSymbol": "MAPK11", + "officialFullName": "mitogen-activated protein kinase 11", + "uniprotAccessionNumber": "Q15759" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/6304726", + "pmid": 6304726, + "title": "Nucleotide sequence of Abelson murine leukemia virus genome: structural similarity of its transforming gene product to other onc gene products with tyrosine-specific kinase activity", + "author": "Reddy EP, Smith MJ, Srinivasan A", + "citation": "Reddy EP, Smith MJ, Srinivasan A. Nucleotide sequence of Abelson murine leukemia virus genome: structural similarity of its transforming gene product to other onc gene products with tyrosine-specific kinase activity. Proc Natl Acad Sci U S A. 1983 Jun;80(12):3623-7. PubMed PMID: 6304726; PubMed Central PMCID: PMC394102.", + "otherId": "0", + "citationId": 118, + "otherSource": "" + } + }, + { + "aeid": 477, + "assayComponentEndpointName": "NVS_ENZ_hMAPK3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMAPK3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMAPK3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MAPK3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 280, + "assayComponentName": "NVS_ENZ_hMAPK3", + "assayComponentDesc": "NVS_ENZ_hMAPK3 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMAPK3 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human mitogen-activated protein kinase 3 [GeneSymbol:MAPK3 | GeneID:5595 | Uniprot_SwissProt_Accession:P27361].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 94, + "assayName": "NVS_ENZ_hMAPK3", + "assayDesc": "NVS_ENZ_hMAPK3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 260, + "geneName": "mitogen-activated protein kinase 3", + "description": null, + "geneSymbol": "MAPK3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5595, + "officialSymbol": "MAPK3", + "officialFullName": "mitogen-activated protein kinase 3", + "uniprotAccessionNumber": "P27361" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 479, + "assayComponentEndpointName": "NVS_ENZ_hMAPKAPK2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMAPKAPK2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMAPKAPK2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MAPKAPK2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 281, + "assayComponentName": "NVS_ENZ_hMAPKAPK2", + "assayComponentDesc": "NVS_ENZ_hMAPKAPK2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMAPKAPK2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human mitogen-activated protein kinase-activated protein kinase 2 [GeneSymbol:MAPKAPK2 | GeneID:9261 | Uniprot_SwissProt_Accession:P49137].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 95, + "assayName": "NVS_ENZ_hMAPKAPK2", + "assayDesc": "NVS_ENZ_hMAPKAPK2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 352, + "geneName": "mitogen-activated protein kinase-activated protein kinase 2", + "description": null, + "geneSymbol": "MAPKAPK2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9261, + "officialSymbol": "MAPKAPK2", + "officialFullName": "mitogen-activated protein kinase-activated protein kinase 2", + "uniprotAccessionNumber": "P49137" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 481, + "assayComponentEndpointName": "NVS_ENZ_hMAPKAPK5", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMAPKAPK5 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMAPKAPK5, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MAPKAPK5. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 282, + "assayComponentName": "NVS_ENZ_hMAPKAPK5", + "assayComponentDesc": "NVS_ENZ_hMAPKAPK5 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMAPKAPK5 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human mitogen-activated protein kinase-activated protein kinase 5 [GeneSymbol:MAPKAPK5 | GeneID:8550 | Uniprot_SwissProt_Accession:Q8IW41].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 96, + "assayName": "NVS_ENZ_hMAPKAPK5", + "assayDesc": "NVS_ENZ_hMAPKAPK5 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 343, + "geneName": "mitogen-activated protein kinase-activated protein kinase 5", + "description": null, + "geneSymbol": "MAPKAPK5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8550, + "officialSymbol": "MAPKAPK5", + "officialFullName": "mitogen-activated protein kinase-activated protein kinase 5", + "uniprotAccessionNumber": "Q8IW41" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 483, + "assayComponentEndpointName": "NVS_ENZ_hMARK1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMARK1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMARK1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MARK1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 283, + "assayComponentName": "NVS_ENZ_hMARK1", + "assayComponentDesc": "NVS_ENZ_hMARK1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMARK1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human MAP/microtubule affinity-regulating kinase 1 [GeneSymbol:MARK1 | GeneID:4139 | Uniprot_SwissProt_Accession:Q9P0L2].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 97, + "assayName": "NVS_ENZ_hMARK1", + "assayDesc": "NVS_ENZ_hMARK1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 198, + "geneName": "MAP/microtubule affinity-regulating kinase 1", + "description": null, + "geneSymbol": "MARK1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4139, + "officialSymbol": "MARK1", + "officialFullName": "MAP/microtubule affinity-regulating kinase 1", + "uniprotAccessionNumber": "Q9P0L2" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 485, + "assayComponentEndpointName": "NVS_ENZ_hMet", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMet was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMet, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MET. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is receptor tyrosine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "receptor", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "receptor tyrosine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 284, + "assayComponentName": "NVS_ENZ_hMet", + "assayComponentDesc": "NVS_ENZ_hMet is one of one assay component(s) measured or calculated from the NVS_ENZ_hMet assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in receptor function and kinetics for the human MET proto-oncogene, receptor tyrosine kinase [GeneSymbol:MET | GeneID:4233 | Uniprot_SwissProt_Accession:P08581].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "receptor", + "aid": 98, + "assayName": "NVS_ENZ_hMet", + "assayDesc": "NVS_ENZ_hMet is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 200, + "geneName": "MET proto-oncogene, receptor tyrosine kinase", + "description": null, + "geneSymbol": "MET", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4233, + "officialSymbol": "MET", + "officialFullName": "MET proto-oncogene, receptor tyrosine kinase", + "uniprotAccessionNumber": "P08581" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 487, + "assayComponentEndpointName": "NVS_ENZ_hMMP1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMMP1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMMP1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MMP1. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metalloproteinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Galardin (GM6001)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 285, + "assayComponentName": "NVS_ENZ_hMMP1", + "assayComponentDesc": "NVS_ENZ_hMMP1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMMP1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:DNPPChaGCHAK(N-Me-Abz)-NH2 --> DNPPChaG + CHAK(N-Me-Abz)-NH2] involving the key substrate [DNP-Pro-(b-cyclohexylalanyl)-Gly-Cys(Me)-His-Ala-Lys(N-Me-2-aminobenzoyl(anthraniloyl))-NH2] are indicative of changes in enzyme function and kinetics for the human matrix metallopeptidase 1 (interstitial collagenase) [GeneSymbol:MMP1 | GeneID:4312 | Uniprot_SwissProt_Accession:P03956].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "DNP-Pro-(b-cyclohexylalanyl)-Gly-Cys(Me)-His-Ala-Lys(N-Me-2-aminobenzoyl(anthraniloyl))-NH2", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 99, + "assayName": "NVS_ENZ_hMMP1", + "assayDesc": "NVS_ENZ_hMMP1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 203, + "geneName": "matrix metallopeptidase 1 (interstitial collagenase)", + "description": null, + "geneSymbol": "MMP1", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4312, + "officialSymbol": "MMP1", + "officialFullName": "matrix metallopeptidase 1 (interstitial collagenase)", + "uniprotAccessionNumber": "P03956" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1537400", + "pmid": 1537400, + "title": "A novel coumarin-labelled peptide for sensitive continuous assays of the matrix metalloproteinases", + "author": "Knight CG, Willenbrock F, Murphy G", + "citation": "Knight CG, Willenbrock F, Murphy G. A novel coumarin-labelled peptide for sensitive continuous assays of the matrix metalloproteinases. FEBS Lett. 1992 Jan 27;296(3):263-6. PubMed PMID: 1537400.", + "otherId": "0", + "citationId": 17, + "otherSource": "" + } + }, + { + "aeid": 489, + "assayComponentEndpointName": "NVS_ENZ_hMMP13", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMMP13 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMMP13, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MMP13. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metalloproteinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Tyr-Hydroxamic acid", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 286, + "assayComponentName": "NVS_ENZ_hMMP13", + "assayComponentDesc": "NVS_ENZ_hMMP13 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMMP13 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:McaPLGLDpaARNH2 --> McaPLG + LDpaARNH2] involving the key substrate [Mca-Pro-Leu-Gly-Leu-Dpa-Ala-Arg-NH2] are indicative of changes in enzyme function and kinetics for the human matrix metallopeptidase 13 (collagenase 3) [GeneSymbol:MMP13 | GeneID:4322 | Uniprot_SwissProt_Accession:P45452].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Mca-Pro-Leu-Gly-Leu-Dpa-Ala-Arg-NH2", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 100, + "assayName": "NVS_ENZ_hMMP13", + "assayDesc": "NVS_ENZ_hMMP13 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 209, + "geneName": "matrix metallopeptidase 13 (collagenase 3)", + "description": null, + "geneSymbol": "MMP13", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4322, + "officialSymbol": "MMP13", + "officialFullName": "matrix metallopeptidase 13 (collagenase 3)", + "uniprotAccessionNumber": "P45452" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1537400", + "pmid": 1537400, + "title": "A novel coumarin-labelled peptide for sensitive continuous assays of the matrix metalloproteinases", + "author": "Knight CG, Willenbrock F, Murphy G", + "citation": "Knight CG, Willenbrock F, Murphy G. A novel coumarin-labelled peptide for sensitive continuous assays of the matrix metalloproteinases. FEBS Lett. 1992 Jan 27;296(3):263-6. PubMed PMID: 1537400.", + "otherId": "0", + "citationId": 17, + "otherSource": "" + } + }, + { + "aeid": 491, + "assayComponentEndpointName": "NVS_ENZ_hMMP2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMMP2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMMP2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MMP2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metalloproteinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Galardin (GM6001)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 287, + "assayComponentName": "NVS_ENZ_hMMP2", + "assayComponentDesc": "NVS_ENZ_hMMP2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMMP2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:McaPLGLDpaARNH2 --> McaPLG + LDpaARNH2] involving the key substrate [Mca-Pro-Leu-Gly-Leu-Dpa-Ala-Arg-NH2] are indicative of changes in enzyme function and kinetics for the human matrix metallopeptidase 2 (gelatinase A, 72kDa gelatinase, 72kDa type IV collagenase) [GeneSymbol:MMP2 | GeneID:4313 | Uniprot_SwissProt_Accession:P08253].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Mca-Pro-Leu-Gly-Leu-Dpa-Ala-Arg-NH2", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 101, + "assayName": "NVS_ENZ_hMMP2", + "assayDesc": "NVS_ENZ_hMMP2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 204, + "geneName": "matrix metallopeptidase 2 (gelatinase A, 72kDa gelatinase, 72kDa type IV collagenase)", + "description": null, + "geneSymbol": "MMP2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4313, + "officialSymbol": "MMP2", + "officialFullName": "matrix metallopeptidase 2 (gelatinase A, 72kDa gelatinase, 72kDa type IV collagenase)", + "uniprotAccessionNumber": "P08253" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1537400", + "pmid": 1537400, + "title": "A novel coumarin-labelled peptide for sensitive continuous assays of the matrix metalloproteinases", + "author": "Knight CG, Willenbrock F, Murphy G", + "citation": "Knight CG, Willenbrock F, Murphy G. A novel coumarin-labelled peptide for sensitive continuous assays of the matrix metalloproteinases. FEBS Lett. 1992 Jan 27;296(3):263-6. PubMed PMID: 1537400.", + "otherId": "0", + "citationId": 17, + "otherSource": "" + } + }, + { + "aeid": 493, + "assayComponentEndpointName": "NVS_ENZ_hMMP3", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMMP3 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMMP3, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MMP3. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metalloproteinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Galardin (GM6001)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 288, + "assayComponentName": "NVS_ENZ_hMMP3", + "assayComponentDesc": "NVS_ENZ_hMMP3 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMMP3 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Mca-RPKPVENvalWRK-Dnp-NH2 --> McaRPK + PVENvalWRK(DNP)NH2] involving the key substrate [Mca-Arg-Pro-Lys-Pro-Val-Glu-Nval-Trp-Arg-Lys(Dnp)NH2] are indicative of changes in enzyme function and kinetics for the human matrix metallopeptidase 3 (stromelysin 1, progelatinase) [GeneSymbol:MMP3 | GeneID:4314 | Uniprot_SwissProt_Accession:P08254].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Mca-Arg-Pro-Lys-Pro-Val-Glu-Nval-Trp-Arg-Lys(Dnp)NH2", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 102, + "assayName": "NVS_ENZ_hMMP3", + "assayDesc": "NVS_ENZ_hMMP3 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 205, + "geneName": "matrix metallopeptidase 3 (stromelysin 1, progelatinase)", + "description": null, + "geneSymbol": "MMP3", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4314, + "officialSymbol": "MMP3", + "officialFullName": "matrix metallopeptidase 3 (stromelysin 1, progelatinase)", + "uniprotAccessionNumber": "P08254" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1537400", + "pmid": 1537400, + "title": "A novel coumarin-labelled peptide for sensitive continuous assays of the matrix metalloproteinases", + "author": "Knight CG, Willenbrock F, Murphy G", + "citation": "Knight CG, Willenbrock F, Murphy G. A novel coumarin-labelled peptide for sensitive continuous assays of the matrix metalloproteinases. FEBS Lett. 1992 Jan 27;296(3):263-6. PubMed PMID: 1537400.", + "otherId": "0", + "citationId": 17, + "otherSource": "" + } + }, + { + "aeid": 495, + "assayComponentEndpointName": "NVS_ENZ_hMMP7", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMMP7 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMMP7, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MMP7. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metalloproteinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Galardin (GM6001)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 289, + "assayComponentName": "NVS_ENZ_hMMP7", + "assayComponentDesc": "NVS_ENZ_hMMP7 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMMP7 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:McaPLGLDpaARNH2 --> McaPLG + LDpaARNH2] involving the key substrate [Mca-Pro-Leu-Gly-Leu-Dpa-Ala-Arg-NH2] are indicative of changes in enzyme function and kinetics for the human matrix metallopeptidase 7 (matrilysin, uterine) [GeneSymbol:MMP7 | GeneID:4316 | Uniprot_SwissProt_Accession:P09237].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Mca-Pro-Leu-Gly-Leu-Dpa-Ala-Arg-NH2", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 103, + "assayName": "NVS_ENZ_hMMP7", + "assayDesc": "NVS_ENZ_hMMP7 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 206, + "geneName": "matrix metallopeptidase 7 (matrilysin, uterine)", + "description": null, + "geneSymbol": "MMP7", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4316, + "officialSymbol": "MMP7", + "officialFullName": "matrix metallopeptidase 7 (matrilysin, uterine)", + "uniprotAccessionNumber": "P09237" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/1537400", + "pmid": 1537400, + "title": "A novel coumarin-labelled peptide for sensitive continuous assays of the matrix metalloproteinases", + "author": "Knight CG, Willenbrock F, Murphy G", + "citation": "Knight CG, Willenbrock F, Murphy G. A novel coumarin-labelled peptide for sensitive continuous assays of the matrix metalloproteinases. FEBS Lett. 1992 Jan 27;296(3):263-6. PubMed PMID: 1537400.", + "otherId": "0", + "citationId": 17, + "otherSource": "" + } + }, + { + "aeid": 497, + "assayComponentEndpointName": "NVS_ENZ_hMMP9", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMMP9 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMMP9, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene MMP9. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the protease intended target family, where the subfamily is matrix metalloproteinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Galardin (GM6001)", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "protease", + "intendedTargetFamilySub": "matrix metalloproteinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 290, + "assayComponentName": "NVS_ENZ_hMMP9", + "assayComponentDesc": "NVS_ENZ_hMMP9 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMMP9 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:DNPPChaGCHAK(N-Me-Abz)-NH2 --> DNPPChaG + CHAK(N-Me-Abz)-NH2] involving the key substrate [DNP-Pro-(b-cyclohexylalanyl)-Gly-Cys(Me)-His-Ala-Lys(N-Me-2-aminobenzoyl(anthraniloyl))-NH2] are indicative of changes in enzyme function and kinetics for the human matrix metallopeptidase 9 (gelatinase B, 92kDa gelatinase, 92kDa type IV collagenase) [GeneSymbol:MMP9 | GeneID:4318 | Uniprot_SwissProt_Accession:P14780].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "DNP-Pro-(b-cyclohexylalanyl)-Gly-Cys(Me)-His-Ala-Lys(N-Me-2-aminobenzoyl(anthraniloyl))-NH2", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 104, + "assayName": "NVS_ENZ_hMMP9", + "assayDesc": "NVS_ENZ_hMMP9 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 96-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 96-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 207, + "geneName": "matrix metallopeptidase 9 (gelatinase B, 92kDa gelatinase, 92kDa type IV collagenase)", + "description": null, + "geneSymbol": "MMP9", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4318, + "officialSymbol": "MMP9", + "officialFullName": "matrix metallopeptidase 9 (gelatinase B, 92kDa gelatinase, 92kDa type IV collagenase)", + "uniprotAccessionNumber": "P14780" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/8368516", + "pmid": 8368516, + "title": "A high throughput fluorogenic substrate for interstitial collagenase (MMP-1) and gelatinase (MMP-9)", + "author": "Bickett DM, Green MD, Berman J, Dezube M, Howe AS, Brown PJ, Roth JT, McGeehan GM", + "citation": "Bickett DM, Green MD, Berman J, Dezube M, Howe AS, Brown PJ, Roth JT, McGeehan GM. A high throughput fluorogenic substrate for interstitial collagenase (MMP-1) and gelatinase (MMP-9). Anal Biochem. 1993 Jul;212(1):58-64. PubMed PMID: 8368516.", + "otherId": "0", + "citationId": 160, + "otherSource": "" + } + }, + { + "aeid": 499, + "assayComponentEndpointName": "NVS_ENZ_hMsk1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hMsk1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hMsk1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene RPS6KA5. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 291, + "assayComponentName": "NVS_ENZ_hMsk1", + "assayComponentDesc": "NVS_ENZ_hMsk1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hMsk1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human ribosomal protein S6 kinase, 90kDa, polypeptide 5 [GeneSymbol:RPS6KA5 | GeneID:9252 | Uniprot_SwissProt_Accession:O75582].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 105, + "assayName": "NVS_ENZ_hMsk1", + "assayDesc": "NVS_ENZ_hMsk1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 351, + "geneName": "ribosomal protein S6 kinase, 90kDa, polypeptide 5", + "description": null, + "geneSymbol": "RPS6KA5", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 9252, + "officialSymbol": "RPS6KA5", + "officialFullName": "ribosomal protein S6 kinase, 90kDa, polypeptide 5", + "uniprotAccessionNumber": "O75582" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 501, + "assayComponentEndpointName": "NVS_ENZ_hNEK2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hNEK2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hNEK2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene NEK2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 292, + "assayComponentName": "NVS_ENZ_hNEK2", + "assayComponentDesc": "NVS_ENZ_hNEK2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hNEK2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human NIMA-related kinase 2 [GeneSymbol:NEK2 | GeneID:4751 | Uniprot_SwissProt_Accession:P51955].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 106, + "assayName": "NVS_ENZ_hNEK2", + "assayDesc": "NVS_ENZ_hNEK2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 215, + "geneName": "NIMA-related kinase 2", + "description": null, + "geneSymbol": "NEK2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 4751, + "officialSymbol": "NEK2", + "officialFullName": "NIMA-related kinase 2", + "uniprotAccessionNumber": "P51955" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 503, + "assayComponentEndpointName": "NVS_ENZ_hPAK2", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPAK2 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPAK2, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PAK2. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 293, + "assayComponentName": "NVS_ENZ_hPAK2", + "assayComponentDesc": "NVS_ENZ_hPAK2 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPAK2 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human p21 protein (Cdc42/Rac)-activated kinase 2 [GeneSymbol:PAK2 | GeneID:5062 | Uniprot_SwissProt_Accession:Q13177].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 107, + "assayName": "NVS_ENZ_hPAK2", + "assayDesc": "NVS_ENZ_hPAK2 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 230, + "geneName": "p21 protein (Cdc42/Rac)-activated kinase 2", + "description": null, + "geneSymbol": "PAK2", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5062, + "officialSymbol": "PAK2", + "officialFullName": "p21 protein (Cdc42/Rac)-activated kinase 2", + "uniprotAccessionNumber": "Q13177" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 505, + "assayComponentEndpointName": "NVS_ENZ_hPAK4", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPAK4 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPAK4, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PAK4. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 294, + "assayComponentName": "NVS_ENZ_hPAK4", + "assayComponentDesc": "NVS_ENZ_hPAK4 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPAK4 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human p21 protein (Cdc42/Rac)-activated kinase 4 [GeneSymbol:PAK4 | GeneID:10298 | Uniprot_SwissProt_Accession:O96013].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 108, + "assayName": "NVS_ENZ_hPAK4", + "assayDesc": "NVS_ENZ_hPAK4 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 364, + "geneName": "p21 protein (Cdc42/Rac)-activated kinase 4", + "description": null, + "geneSymbol": "PAK4", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10298, + "officialSymbol": "PAK4", + "officialFullName": "p21 protein (Cdc42/Rac)-activated kinase 4", + "uniprotAccessionNumber": "O96013" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 507, + "assayComponentEndpointName": "NVS_ENZ_hPDE10", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPDE10 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPDE10, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PDE10A. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "trequinsin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 295, + "assayComponentName": "NVS_ENZ_hPDE10", + "assayComponentDesc": "NVS_ENZ_hPDE10 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE10 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic AMP --> Flourescent 5?-AMP] involving the key substrate [Fluorescent cyclic AMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 10A [GeneSymbol:PDE10A | GeneID:10846 | Uniprot_SwissProt_Accession:Q9Y233].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic AMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 109, + "assayName": "NVS_ENZ_hPDE10", + "assayDesc": "NVS_ENZ_hPDE10 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 368, + "geneName": "phosphodiesterase 10A", + "description": null, + "geneSymbol": "PDE10A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 10846, + "officialSymbol": "PDE10A", + "officialFullName": "phosphodiesterase 10A", + "uniprotAccessionNumber": "Q9Y233" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 509, + "assayComponentEndpointName": "NVS_ENZ_hPDE4A1", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPDE4A1 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPDE4A1, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PDE4A. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "trequinsin", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 296, + "assayComponentName": "NVS_ENZ_hPDE4A1", + "assayComponentDesc": "NVS_ENZ_hPDE4A1 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE4A1 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic AMP --> Flourescent 5?-AMP] involving the key substrate [Fluorescent cyclic AMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 4A, cAMP-specific [GeneSymbol:PDE4A | GeneID:5141 | Uniprot_SwissProt_Accession:P27815].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic AMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 110, + "assayName": "NVS_ENZ_hPDE4A1", + "assayDesc": "NVS_ENZ_hPDE4A1 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 232, + "geneName": "phosphodiesterase 4A, cAMP-specific", + "description": null, + "geneSymbol": "PDE4A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5141, + "officialSymbol": "PDE4A", + "officialFullName": "phosphodiesterase 4A, cAMP-specific", + "uniprotAccessionNumber": "P27815" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 511, + "assayComponentEndpointName": "NVS_ENZ_hPDE5", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPDE5 was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPDE5, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PDE5A. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the esterase intended target family, where the subfamily is phosphodiesterase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Dipyridamole", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "esterase", + "intendedTargetFamilySub": "phosphodiesterase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 297, + "assayComponentName": "NVS_ENZ_hPDE5", + "assayComponentDesc": "NVS_ENZ_hPDE5 is one of one assay component(s) measured or calculated from the NVS_ENZ_hPDE5 assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescent cyclic GMP --> Flourescent 5?-GMP] involving the key substrate [Fluorescent cyclic GMP] are indicative of changes in enzyme function and kinetics for the human phosphodiesterase 5A, cGMP-specific [GeneSymbol:PDE5A | GeneID:8654 | Uniprot_SwissProt_Accession:O76074].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescent cyclic GMP", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 111, + "assayName": "NVS_ENZ_hPDE5", + "assayDesc": "NVS_ENZ_hPDE5 is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 346, + "geneName": "phosphodiesterase 5A, cGMP-specific", + "description": null, + "geneSymbol": "PDE5A", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 8654, + "officialSymbol": "PDE5A", + "officialFullName": "phosphodiesterase 5A, cGMP-specific", + "uniprotAccessionNumber": "O76074" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 513, + "assayComponentEndpointName": "NVS_ENZ_hPI3Ka", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPI3Ka was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPI3Ka, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PIK3CA. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is phosphoinositol kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "PI-103", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "phosphoinositol kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 298, + "assayComponentName": "NVS_ENZ_hPI3Ka", + "assayComponentDesc": "NVS_ENZ_hPI3Ka is one of one assay component(s) measured or calculated from the NVS_ENZ_hPI3Ka assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-PIP2 + ATP --> fluorescein-PIP3 + ADP] involving the key substrate [Fluorescein-labeled PIP2 (phosphoinositol (4,5)bisphosphate)] are indicative of changes in enzyme function and kinetics for the human phosphatidylinositol-4,5-bisphosphate 3-kinase, catalytic subunit alpha [GeneSymbol:PIK3CA | GeneID:5290 | Uniprot_SwissProt_Accession:P42336].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled PIP2 (phosphoinositol (4,5)bisphosphate)", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 112, + "assayName": "NVS_ENZ_hPI3Ka", + "assayDesc": "NVS_ENZ_hPI3Ka is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 237, + "geneName": "phosphatidylinositol-4,5-bisphosphate 3-kinase, catalytic subunit alpha", + "description": null, + "geneSymbol": "PIK3CA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5290, + "officialSymbol": "PIK3CA", + "officialFullName": "phosphatidylinositol-4,5-bisphosphate 3-kinase, catalytic subunit alpha", + "uniprotAccessionNumber": "P42336" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + }, + { + "aeid": 515, + "assayComponentEndpointName": "NVS_ENZ_hPKA", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPKA was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPKA, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PRKACA. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "H 89", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 299, + "assayComponentName": "NVS_ENZ_hPKA", + "assayComponentDesc": "NVS_ENZ_hPKA is one of one assay component(s) measured or calculated from the NVS_ENZ_hPKA assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human protein kinase, cAMP-dependent, catalytic, alpha [GeneSymbol:PRKACA | GeneID:5566 | Uniprot_SwissProt_Accession:P17612].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 113, + "assayName": "NVS_ENZ_hPKA", + "assayDesc": "NVS_ENZ_hPKA is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 256, + "geneName": "protein kinase, cAMP-dependent, catalytic, alpha", + "description": null, + "geneSymbol": "PRKACA", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5566, + "officialSymbol": "PRKACA", + "officialFullName": "protein kinase, cAMP-dependent, catalytic, alpha", + "uniprotAccessionNumber": "P17612" + }, + "assayList": null, + "citations": { + "doi": "", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/10998351", + "pmid": 10998351, + "title": "Specificity and mechanism of action of some commonly used protein kinase inhibitors", + "author": "Davies SP, Reddy H, Caivano M, Cohen P", + "citation": "Davies SP, Reddy H, Caivano M, Cohen P. Specificity and mechanism of action of some commonly used protein kinase inhibitors. Biochem J. 2000 Oct 1;351(Pt 1):95-105. PubMed PMID: 10998351; PubMed Central PMCID: PMC1221339.", + "otherId": "0", + "citationId": 184, + "otherSource": "" + } + }, + { + "aeid": 517, + "assayComponentEndpointName": "NVS_ENZ_hPKCz", + "exportReady": 1, + "internalReady": 1, + "assayComponentEndpointDesc": "Data from the assay component NVS_ENZ_hPKCz was analyzed into 1 assay endpoint. This assay endpoint, NVS_ENZ_hPKCz, was analyzed in the positive analysis fitting direction relative to DMSO as the negative control and baseline of activity. \r\nUsing a type of enzyme reporter, loss-of-signal activity can be used to understand changes in the enzymatic activity as they relate to the gene PRKCZ. \r\nFurthermore, this assay endpoint can be referred to as a primary readout, because this assay has produced multiple assay endpoints where this one serves a enzymatic activity function. \r\nTo generalize the intended target to other relatable targets, this assay endpoint is annotated to the kinase intended target family, where the subfamily is serine/threonine kinase.", + "assayFunctionType": "enzymatic activity", + "normalizedDataType": "percent_activity", + "burstAssay": 0, + "keyPositiveControl": "Staurosporine", + "signalDirection": "loss", + "intendedTargetType": "protein", + "intendedTargetTypeSub": "enzyme", + "intendedTargetFamily": "kinase", + "intendedTargetFamilySub": "serine/threonine kinase", + "cellViabilityAssay": 0, + "dataUsability": 1, + "acid": 300, + "assayComponentName": "NVS_ENZ_hPKCz", + "assayComponentDesc": "NVS_ENZ_hPKCz is one of one assay component(s) measured or calculated from the NVS_ENZ_hPKCz assay. It is designed to make measurements of enzyme activity, a form of enzyme reporter, as detected with fluorescence intensity signals by Fluorescence and electrophoretic mobility shift technology.", + "assayComponentTargetDesc": "Changes to fluorescence intensity signals produced from an enzymatic reaction [Reaction:Fluorescein-peptide + ATP --> fluorescein-phosphopeptide + ADP] involving the key substrate [Fluorescein-labeled peptide] are indicative of changes in enzyme function and kinetics for the human protein kinase C, zeta [GeneSymbol:PRKCZ | GeneID:5590 | Uniprot_SwissProt_Accession:Q05513].", + "parameterReadoutType": "single", + "assayDesignType": "enzyme reporter", + "assayDesignTypeSub": "enzyme activity", + "biologicalProcessTarget": "regulation of catalytic activity", + "detectionTechnologyType": "Fluorescence", + "detectionTechnologyTypeSub": "Fluorescence intensity", + "detectionTechnology": "Fluorescence and electrophoretic mobility shift", + "keyAssayReagentType": "substrate", + "keyAssayReagent": "Fluorescein-labeled peptide", + "technologicalTargetType": "protein", + "technologicalTargetTypeSub": "enzyme", + "aid": 114, + "assayName": "NVS_ENZ_hPKCz", + "assayDesc": "NVS_ENZ_hPKCz is a biochemical, single-readout assay that uses extracted gene-proteins in a cell-free assay. Measurements were taken 1 hour after chemical dosing in a 384-well plate.", + "timepointHr": 1.0, + "organismId": 9606, + "organism": "human", + "tissue": "NA", + "cellFormat": "cell-free", + "cellFreeComponentSource": "NA", + "cellShortName": "NA", + "cellGrowthMode": "NA", + "assayFootprint": "microplate: 384-well plate", + "assayFormatType": "biochemical", + "assayFormatTypeSub": "protein single format", + "contentReadoutType": "single", + "dilutionSolvent": "DMSO", + "dilutionSolventPercentMax": 0.0, + "asid": 5, + "assaySourceName": "NVS", + "assaySourceLongName": "Novascreen", + "assaySourceDesc": "NovaScreen, part of PerkinElmer, a human and environmental health company, provides a large diverse suite of cell-free binding and biochemical assays.", + "gene": { + "geneId": 258, + "geneName": "protein kinase C, zeta", + "description": null, + "geneSymbol": "PRKCZ", + "organismId": 1, + "trackStatus": "live", + "entrezGeneId": 5590, + "officialSymbol": "PRKCZ", + "officialFullName": "protein kinase C, zeta", + "uniprotAccessionNumber": "Q05513" + }, + "assayList": null, + "citations": { + "doi": "doi: 10.1021/tx400021f", + "url": "http://www.ncbi.nlm.nih.gov/pubmed/23611293", + "pmid": 23611293, + "title": "Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays", + "author": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB", + "citation": "Sipes NS, Martin MT, Kothiya P, Reif DM, Judson RS, Richard AM, Houck KA, Dix DJ, Kavlock RJ, Knudsen TB. Profiling 976 ToxCast chemicals across 331 enzymatic and receptor signaling assays. Chem Res Toxicol. 2013 Jun 17;26(6):878-95. doi: 10.1021/tx400021f. Epub 2013 May 16. PubMed PMID: 23611293; PubMed Central PMCID: PMC3685188.", + "otherId": "0", + "citationId": 215, + "otherSource": "" + } + } +] diff --git a/vignettes/api/0/api-ccte.epa.gov/bioactivity/data/search/by-aeid/704.json b/vignettes/api/0/api-ccte.epa.gov/bioactivity/data/search/by-aeid/704.json new file mode 100644 index 00000000..a329279d --- /dev/null +++ b/vignettes/api/0/api-ccte.epa.gov/bioactivity/data/search/by-aeid/704.json @@ -0,0 +1,9207 @@ +[ + { + "aeid": 704, + "m4id": 1842410, + "spid": "LEGTV002G10", + "chid": 32577, + "casn": "79538-32-2", + "chnm": "Tefluthrin", + "dtxsid": "DTXSID5032577", + "bmad": 3.7634679299683276, + "respMax": 22.88978034849851, + "respMin": -26.552798250251374, + "maxMean": 22.88978034849851, + "maxMeanConc": 0.7781512503836436, + "maxMed": 22.88978034849851, + "maxMedConc": 0.7781512503836436, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 4, + "tmpi": 9, + "m5id": 5037056, + "modl": "exp4", + "hitc": 0.2411318116914611, + "fitc": 15, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -1.6989700043360187, + -0.22184874961635637, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + 1.6989700043360187, + 0.3010299956639812 + ], + "resp": [ + -26.552798250251374, + 7.643488716816449, + 22.88978034849851, + 7.9412465922401445, + 19.249048936986245, + 22.72625970498906, + 20.26645313099273, + 10.220169791958208 + ] + }, + "mc4Param": { + "pow_a": 8.051875026642751, + "pow_p": 0.3000002363252646, + "exp2_a": 2586.5273948186914, + "exp2_b": 5061.903524643174, + "exp3_a": 16.991620306804258, + "exp3_b": 61.307930252068054, + "exp3_p": 0.3000001542012486, + "exp5_p": 0.41109358960702536, + "gnls_p": 0.5634256102787089, + "gnls_q": 7.950665366879992, + "hill_p": 0.5634498524518311, + "pow_er": 2.1767434212836925, + "cnst_er": 2.8698019137772666, + "exp2_er": 2.623207281861648, + "exp3_er": 2.3192847401467107, + "exp4_er": 2.1056134978195313, + "exp4_ga": 1.0188231249900932, + "exp4_tp": 20.260251446603277, + "exp5_er": 1.9820127172223416, + "exp5_ga": 0.4248866702697808, + "exp5_tp": 20.7377426492478, + "gnls_er": 1.99625942425146, + "gnls_ga": 0.3960985797099487, + "gnls_la": 4930.779736400695, + "gnls_tp": 21.81742856245767, + "hill_er": 1.996272080662291, + "hill_ga": 0.39605546778034006, + "hill_tp": 21.817114896556166, + "poly1_a": 0.5150479432537712, + "poly2_a": 2323.882444395881, + "poly2_b": 4567.207855100587, + "pow_aic": 68.5758988456374, + "pow_cov": 1, + "pow_rme": 12.721053786887008, + "pow_top": 26.03684923789126, + "all_bmed": 0, + "cnst_aic": 72.9602916781216, + "cnst_rme": 18.54949195654765, + "exp2_aic": 73.57241312566146, + "exp2_cov": 1, + "exp2_rme": 15.498838859238056, + "exp2_top": 25.67555887819936, + "exp3_aic": 71.90187282888056, + "exp3_cov": 1, + "exp3_rme": 13.226439348308494, + "exp3_top": 26.53564273777775, + "exp4_aic": 67.91716461253762, + "exp4_cov": 1, + "exp4_rme": 12.291600328368528, + "exp4_top": 20.260251446603277, + "exp5_aic": 68.74654825043743, + "exp5_cov": 1, + "exp5_rme": 12.205391269508892, + "exp5_top": 20.7377426492478, + "gnls_aic": 72.70908001073246, + "gnls_cov": 0, + "gnls_rme": 12.08907864204856, + "gnls_top": 21.62406269958069, + "hill_aic": 68.70908001125854, + "hill_cov": 1, + "hill_rme": 12.089052602788728, + "hill_top": 21.817114896556166, + "poly1_er": 2.6233806365269072, + "poly2_er": 2.623494262991935, + "pow_a_sd": 18.263178960432903, + "pow_ac50": 4.960637316196675, + "pow_p_sd": 0.697941144406865, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 32716.581509859232, + "exp2_ac50": 25.06173541792207, + "exp2_b_sd": 63813.265454996756, + "exp3_a_sd": null, + "exp3_ac50": 9.809731117071673, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 1.0188231249900932, + "exp5_ac50": 0.4248866702697808, + "exp5_p_sd": 0.34799669960865676, + "gnls_ac50": 0.3838306742682284, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 0.39605546778034006, + "hill_p_sd": 0.635744845964724, + "poly1_aic": 71.56605507092407, + "poly1_cov": 1, + "poly1_rme": 15.493294256204988, + "poly1_top": 25.75239716268856, + "poly2_aic": 73.57994628381844, + "poly2_cov": 1, + "poly2_rme": 15.50431136692914, + "poly2_top": 25.719470980222596, + "pow_er_sd": 1.15655148324573, + "exp2_er_sd": 0.3073701019975029, + "exp3_er_sd": null, + "exp4_er_sd": 0.387701061369176, + "exp4_ga_sd": 1.301060030418642, + "exp4_tp_sd": 4.791141733238257, + "exp5_er_sd": 0.3929731812861924, + "exp5_ga_sd": 0.8430161520344103, + "exp5_tp_sd": 5.937095261163485, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.3920891185604444, + "hill_ga_sd": 1.2602581620806317, + "hill_tp_sd": 10.912262369817968, + "poly1_a_sd": 0.2454616975843716, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 20164.124461380256, + "poly2_ac50": 25.135359225205608, + "poly2_b_sd": 39136.75145557223, + "poly1_er_sd": 0.3073969378754904, + "poly2_er_sd": 0.3073430361679298, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 4935.719934078368 + }, + "mc5Param": { + "er": 2.1056134978195313, + "ga": 1.0188231249900932, + "tp": 20.260251446603277, + "ac5": 0.07539350363763271, + "bmd": 0.9015999983866408, + "bmr": 9.289141683881516, + "mll": -30.95858230626881, + "top": 20.260251446603277, + "ac10": 0.15486426667184697, + "ac20": 0.3279877876552497, + "ac50": 1.0188231249900932, + "bmdl": 0.015249773022781948, + "bmdu": 3.811435874108677, + "rmse": 12.291600328368528, + "ac1sd": 0.6104667435797823, + "caikwt": 0.07436025429585817, + "hitcall": 0.2411318116914611, + "top_over_cutoff": 0.8972332532835738 + }, + "mc6Param": { + "flag": [ + "Multiple points above baseline, inactive", + "Borderline", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 8, + 11, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842408, + "spid": "LEGTV002F02", + "chid": 34634, + "casn": "68157-60-8", + "chnm": "Forchlorfenuron", + "dtxsid": "DTXSID1034634", + "bmad": 3.7634679299683276, + "respMax": 30.305480403437308, + "respMin": -15.782463123633022, + "maxMean": 30.305480403437308, + "maxMeanConc": 1.6989700043360187, + "maxMed": 30.305480403437308, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 2, + "tmpi": 7, + "m5id": 5037054, + "modl": "poly1", + "hitc": 0.6460864720880574, + "fitc": 15, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.7781512503836436, + 1.3010299956639813, + -0.6989700043360187, + 1.6989700043360187, + 0.3010299956639812, + -1.6989700043360187, + -0.22184874961635637, + -1.154901959985743 + ], + "resp": [ + 17.312197447937717, + 5.892444361517972, + -5.621637590571268, + 30.305480403437308, + -12.047921136921975, + -0.9033802904499949, + 3.9506691129976836, + -15.782463123633022 + ] + }, + "mc4Param": { + "pow_a": 0.1234505358742655, + "pow_p": 1.4039572198662018, + "exp2_a": 11.704126631709482, + "exp2_b": 39.21885087510036, + "exp3_a": 6.797876599868359, + "exp3_b": 27.227754995685633, + "exp3_p": 0.8670700138038412, + "exp5_p": 2.243572303903159, + "gnls_p": 3.417276045729987, + "gnls_q": 7.9999995152294145, + "hill_p": 3.410031445934874, + "pow_er": 2.053160430913364, + "cnst_er": 2.4831651329165245, + "exp2_er": 2.0477140196724335, + "exp3_er": 2.045418371135353, + "exp4_er": 2.1440692417744724, + "exp4_ga": 27.444981809921984, + "exp4_tp": 36.36657640836127, + "exp5_er": 2.056168804647671, + "exp5_ga": 33.29374622826353, + "exp5_tp": 36.366576245073674, + "gnls_er": 2.0583941068083926, + "gnls_ga": 31.61205104146836, + "gnls_la": 1534.1122637713574, + "gnls_tp": 36.36657643578302, + "hill_er": 2.058279940276527, + "hill_ga": 31.61029453570885, + "hill_tp": 36.36657616615269, + "poly1_a": 0.5785182000394039, + "poly2_a": 12.459385888548155, + "poly2_b": 44.18199252652262, + "pow_aic": 65.0995287126822, + "pow_cov": 1, + "pow_rme": 9.38736161655436, + "pow_top": 29.976034738668837, + "all_bmed": 0, + "cnst_aic": 67.9344363146865, + "cnst_rme": 14.5564438526066, + "exp2_aic": 65.01101796690389, + "exp2_cov": 1, + "exp2_rme": 9.336855219455533, + "exp2_top": 30.177138850514144, + "exp3_aic": 67.00414392078824, + "exp3_cov": 1, + "exp3_rme": 9.328883445138253, + "exp3_top": 30.184512709969923, + "exp4_aic": 65.8649681972613, + "exp4_cov": 1, + "exp4_rme": 9.540601853567534, + "exp4_top": 36.36657640836127, + "exp5_aic": 67.2557220191338, + "exp5_cov": 1, + "exp5_rme": 9.530978553849964, + "exp5_top": 36.366576245073674, + "gnls_aic": 71.33940383936331, + "gnls_cov": 1, + "gnls_rme": 9.604561582504878, + "gnls_top": 36.36043012871301, + "hill_aic": 67.33939320817458, + "hill_cov": 1, + "hill_rme": 9.604376235570829, + "hill_top": 36.36657616615269, + "poly1_er": 2.085652025408799, + "poly2_er": 2.049820013105159, + "pow_a_sd": 0.5753788358968032, + "pow_ac50": 30.517899763456313, + "pow_p_sd": 1.208640790059217, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 41.73861131597536, + "exp2_ac50": 32.48057507982734, + "exp2_b_sd": 80.2181969794621, + "exp3_a_sd": 55.46148196934477, + "exp3_ac50": 32.61409306497238, + "exp3_b_sd": 155.31132615599387, + "exp3_p_sd": 1.7685350503057042, + "exp4_ac50": 27.444981809921984, + "exp5_ac50": 33.29374622826353, + "exp5_p_sd": 3.435165237165201, + "gnls_ac50": 31.60892429289404, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 31.61029453570885, + "hill_p_sd": 23.432436210259, + "poly1_aic": 63.26368385628203, + "poly1_cov": 1, + "poly1_rme": 9.335379666909818, + "poly1_top": 28.92591000197019, + "poly2_aic": 65.04407548989566, + "poly2_cov": 1, + "poly2_rme": 9.347372572279864, + "poly2_top": 30.056881540429895, + "pow_er_sd": 0.33301411643671863, + "exp2_er_sd": 0.3322758677027563, + "exp3_er_sd": 0.3319875527085669, + "exp4_er_sd": 0.3157481584060974, + "exp4_ga_sd": 34.059639655609715, + "exp4_tp_sd": 26.977496390379052, + "exp5_er_sd": 0.334389570780719, + "exp5_ga_sd": 37.91927313278114, + "exp5_tp_sd": 50.504063030446645, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.33640069974138875, + "hill_ga_sd": 126.4453565783159, + "hill_tp_sd": 150.73989659276037, + "poly1_a_sd": 0.13788942465596515, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 81.28656120170228, + "poly2_ac50": 31.22468556738295, + "poly2_b_sd": 189.87096202288063, + "poly1_er_sd": 0.31798965447224936, + "poly2_er_sd": 0.3317697682239624, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 1534.1764211860095 + }, + "mc5Param": { + "a": 0.5785182000394039, + "er": 2.085652025408799, + "ac5": 2.4999999999999996, + "acc": 39.03214726567279, + "bmd": 16.05678383713566, + "bmr": 9.289141683881516, + "mll": -29.631841928141014, + "top": 28.92591000197019, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 11.311189751842544, + "bmdu": 29.51384383733146, + "rmse": 9.335379666909818, + "ac1sd": 11.902730791056827, + "caikwt": 0.08823518845609243, + "hitcall": 0.6460864720880574, + "top_over_cutoff": 1.2809953718322074 + }, + "mc6Param": { + "flag": [ + "Multiple points above baseline, inactive", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 8, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842409, + "spid": "LEGTV002F07", + "chid": 32392, + "casn": "66441-23-4", + "chnm": "Fenoxaprop-ethyl", + "dtxsid": "DTXSID2032392", + "bmad": 3.7634679299683276, + "respMax": 11.82202000041872, + "respMin": -15.519375841783155, + "maxMean": 11.82202000041872, + "maxMeanConc": -1.6989700043360187, + "maxMed": 11.82202000041872, + "maxMedConc": -1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 1, + "tmpi": 8, + "m5id": 5037055, + "modl": "poly1", + "hitc": 1.4322271531083211E-5, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -1.6989700043360187, + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + -0.22184874961635637, + 1.6989700043360187 + ], + "resp": [ + 11.82202000041872, + 1.5536961694941236, + -15.519375841783155, + -3.18010844609448, + -2.140589126080783, + 8.784412793010326, + -2.3157498063462607, + -0.3023091900039757 + ] + }, + "mc4Param": { + "pow_a": 0.0000011632431730420026, + "pow_p": 0.371275158646456, + "exp2_a": 0.000001797829505777648, + "exp2_b": 72.74913416945634, + "exp3_a": 0.0000055005758644098394, + "exp3_b": 57.760844012588784, + "exp3_p": 6.22085425509824, + "exp5_p": 0.8997002598611641, + "gnls_p": 6.745015045169553, + "gnls_q": 7.999999994872401, + "hill_p": 7.540290076592129, + "pow_er": 1.8022541315256504, + "cnst_er": 1.8015796789499128, + "exp2_er": 1.8007494516437397, + "exp3_er": 1.8021894413500723, + "exp4_er": 1.80158870051793, + "exp4_ga": 7.782862626322558, + "exp4_tp": 3.226750921155688E-9, + "exp5_er": 1.8015912094733963, + "exp5_ga": 8.441755009402286, + "exp5_tp": 7.302557281932975E-10, + "gnls_er": 1.563319486875444, + "gnls_ga": 0.0021571134721910935, + "gnls_la": 0.3339308415916757, + "gnls_tp": 7.623928704938419, + "hill_er": 1.8015890186604628, + "hill_ga": 157.94452896356304, + "hill_tp": 1.8955153678433672, + "poly1_a": 5.662423411973493E-10, + "poly2_a": 0.000022326254566998696, + "poly2_b": 56.36270470222716, + "pow_aic": 61.5780037237116, + "pow_cov": 1, + "pow_rme": 7.748713087460874, + "pow_top": 0.0000049711385820584395, + "all_bmed": 0, + "cnst_aic": 57.57799866553477, + "cnst_rme": 7.748712496775653, + "exp2_aic": 61.578004749066096, + "exp2_cov": 1, + "exp2_rme": 7.748712562373631, + "exp2_top": 0.0000017768428039737286, + "exp3_aic": 63.57800185669078, + "exp3_cov": 1, + "exp3_rme": 7.748712510532352, + "exp3_top": 0.000002767495920583712, + "exp4_aic": 61.577998666698214, + "exp4_cov": 1, + "exp4_rme": 7.748712497203208, + "exp4_top": 3.226750921155688E-9, + "exp5_aic": 63.57799866627887, + "exp5_cov": 1, + "exp5_rme": 7.74871249686776, + "exp5_top": 7.302557281932975E-10, + "gnls_aic": 64.94555137524486, + "gnls_cov": 1, + "gnls_rme": 6.978798723259373, + "gnls_top": 7.6239285577032945, + "hill_aic": 63.57800538783228, + "hill_cov": 1, + "hill_rme": 7.748714090611704, + "hill_top": 1.8955153678433672, + "poly1_er": 1.801569355455974, + "poly2_er": 1.8017915647795937, + "pow_a_sd": null, + "pow_ac50": 7.72982644524005, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 29.213607891471405, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 45.42645739987168, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 7.782862626322558, + "exp5_ac50": 8.441755009402286, + "exp5_p_sd": null, + "gnls_ac50": 0.0021571134162010203, + "gnls_p_sd": 1886.6181378919537, + "gnls_q_sd": 13.897596369316378, + "hill_ac50": 157.94452896356304, + "hill_p_sd": null, + "poly1_aic": 59.577998670402955, + "poly1_cov": 1, + "poly1_rme": 7.748712498123487, + "poly1_top": 2.831211705986746E-8, + "poly2_aic": 61.57800229689971, + "poly2_cov": 1, + "poly2_rme": 7.748713685123689, + "poly2_top": 0.00003737589473088489, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": 0.39059567343598767, + "gnls_ga_sd": 1.343381900673757, + "gnls_la_sd": 0.3212711194493188, + "gnls_tp_sd": 3.818735746599816, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.1026000354392676, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.58306067150831, + "poly2_b_sd": null, + "poly1_er_sd": 0.34707929934562703, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.3339308431136041 + }, + "mc5Param": { + "a": 5.662423411973493E-10, + "er": 1.801569355455974, + "ac5": 2.5, + "bmd": 16404887109.358751, + "bmr": 9.289141683881516, + "mll": -27.78899933520148, + "top": 2.831211705986746E-8, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 62.41443596324167, + "rmse": 7.748712498123487, + "ac1sd": 12160776211.533545, + "caikwt": 0.7310585791085764, + "hitcall": 0.000014322271531083213, + "top_over_cutoff": 1.253813308483351E-9 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842411, + "spid": "LEGTV002H08", + "chid": 34742, + "casn": "NOCAS_34742", + "chnm": "Milbemectin (mixture of 70% Milbemcin A4, 30% Milbemycin A3)", + "dtxsid": "DTXSID8034742", + "bmad": 3.7634679299683276, + "respMax": 73.67532078350177, + "respMin": -5.395088130329359, + "maxMean": 73.67532078350177, + "maxMeanConc": 0.7781512503836436, + "maxMed": 73.67532078350177, + "maxMedConc": 0.7781512503836436, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 6, + "tmpi": 10, + "m5id": 5037057, + "modl": "exp4", + "hitc": 0.9999994968056571, + "fitc": 42, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.3010299956639812, + -1.6989700043360187, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + -0.22184874961635637, + -0.6989700043360187, + 1.6989700043360187 + ], + "resp": [ + 52.505652872749074, + -5.395088130329359, + 73.67532078350177, + 5.395088130329359, + 72.53691394012041, + 19.22317269185714, + 30.263301277685446, + 69.87972321355599 + ] + }, + "mc4Param": { + "pow_a": 28.147886385576328, + "pow_p": 0.30000009689641516, + "exp2_a": 6119.261472113918, + "exp2_b": 3551.239003137988, + "exp3_a": 975.1669226858538, + "exp3_b": 153230.6117998245, + "exp3_p": 0.3000003501105035, + "exp5_p": 1.094805881965073, + "gnls_p": 1.3647130188568126, + "gnls_q": 0.5619058173970354, + "hill_p": 1.59050714992454, + "pow_er": 2.63553254897771, + "cnst_er": 3.795906798840122, + "exp2_er": 3.3954987701188113, + "exp3_er": 2.727845635618811, + "exp4_er": 1.4689672679270718, + "exp4_ga": 1.099878418012791, + "exp4_tp": 72.48760653689077, + "exp5_er": 1.385097799783372, + "exp5_ga": 1.132980663465564, + "exp5_tp": 72.29651505256778, + "gnls_er": 1.3581230433996936, + "gnls_ga": 1.3915857757652723, + "gnls_la": 524.1224234965719, + "gnls_tp": 88.41038117121148, + "hill_er": 1.5970021189190942, + "hill_ga": 1.077282613722834, + "hill_tp": 73.26305717696057, + "poly1_a": 1.7397504631410787, + "poly2_a": 8413.5045447357, + "poly2_b": 4888.583862175059, + "pow_aic": 73.54169876654271, + "pow_cov": 1, + "pow_rme": 15.2861480042891, + "pow_top": 91.02002602025269, + "all_bmed": 0, + "cnst_aic": 88.28390953083002, + "cnst_rme": 49.58992816204983, + "exp2_aic": 86.10951984809975, + "exp2_cov": 1, + "exp2_rme": 34.328944054173824, + "exp2_top": 86.76609362549449, + "exp3_aic": 75.92329672154494, + "exp3_cov": 1, + "exp3_rme": 15.630160935729108, + "exp3_top": 91.8010727392276, + "exp4_aic": 59.2793317878772, + "exp4_cov": 1, + "exp4_rme": 8.238704361671774, + "exp4_top": 72.48760653689077, + "exp5_aic": 61.10190561453248, + "exp5_cov": 1, + "exp5_rme": 8.62848952975195, + "exp5_top": 72.29651505256778, + "gnls_aic": 65.36002423995862, + "gnls_cov": 1, + "gnls_rme": 9.055176915896654, + "gnls_top": 75.01351487350438, + "hill_aic": 63.48641699639106, + "hill_cov": 1, + "hill_rme": 9.621896825468774, + "hill_top": 73.26305717696057, + "poly1_er": 3.393356939188565, + "poly2_er": 3.3954441024657243, + "pow_a_sd": 8.463344228881985, + "pow_ac50": 4.960631989323517, + "pow_p_sd": 0.09202961052734752, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 44830.330426869536, + "exp2_ac50": 25.087996729753247, + "exp2_b_sd": 25840.49536754701, + "exp3_a_sd": 1604.028096378901, + "exp3_ac50": 5.3422803072846445, + "exp3_b_sd": 660507.3822297514, + "exp3_p_sd": 0.10541901370789264, + "exp4_ac50": 1.099878418012791, + "exp5_ac50": 1.132980663465564, + "exp5_p_sd": 0.2147453097848282, + "gnls_ac50": 1.158904104169734, + "gnls_p_sd": 0.3461607578247413, + "gnls_q_sd": 0.7944942746221946, + "hill_ac50": 1.077282613722834, + "hill_p_sd": 0.4118849346917922, + "poly1_aic": 84.09047084550053, + "poly1_cov": 1, + "poly1_rme": 34.282455965850914, + "poly1_top": 86.98752315705393, + "poly2_aic": 86.11783010298875, + "poly2_cov": 1, + "poly2_rme": 34.3417360780736, + "poly2_top": 86.93271261079072, + "pow_er_sd": 0.32772739565048525, + "exp2_er_sd": 0.3154107490786174, + "exp3_er_sd": 0.34995551663162316, + "exp4_er_sd": 0.3801021109960385, + "exp4_ga_sd": 0.15804671767015727, + "exp4_tp_sd": 2.557860936885942, + "exp5_er_sd": 0.4212709024359285, + "exp5_ga_sd": 0.1485229561872174, + "exp5_tp_sd": 2.346998337980212, + "gnls_er_sd": 0.4418044445090503, + "gnls_ga_sd": 0.4322859035235454, + "gnls_la_sd": 1067.6005455781465, + "gnls_tp_sd": 26.852332203983984, + "hill_er_sd": 0.39657332639532145, + "hill_ga_sd": 0.16949083304776472, + "hill_tp_sd": 3.4053560285886713, + "poly1_a_sd": 0.5875701839815818, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 52103.4262311332, + "poly2_ac50": 25.12655125481741, + "poly2_b_sd": 29886.906099027077, + "poly1_er_sd": 0.31507639708506446, + "poly2_er_sd": 0.31533923357704763, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 902.1729967630253 + }, + "mc5Param": { + "er": 1.4689672679270718, + "ga": 1.099878418012791, + "tp": 72.48760653689077, + "ac5": 0.08139164245040806, + "acc": 0.59228230830365, + "bmd": 0.21760526858009044, + "bmr": 9.289141683881516, + "mll": -26.6396658939386, + "top": 72.48760653689077, + "ac10": 0.167184921951392, + "ac20": 0.3540817637185837, + "ac50": 1.099878418012791, + "bmdl": 0.17276594676938292, + "bmdu": 0.2697433120933787, + "rmse": 8.238704361671774, + "ac1sd": 0.15838472357506664, + "caikwt": 5.031943424985008E-7, + "hitcall": 0.9999994968056573, + "top_over_cutoff": 3.210142342371477 + }, + "mc6Param": { + "flag": [ + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842412, + "spid": "LEGTV003B07", + "chid": 23892, + "casn": "71751-41-2", + "chnm": "Abamectin", + "dtxsid": "DTXSID8023892", + "bmad": 3.7634679299683276, + "respMax": 77.95705815614956, + "respMin": -28.22028225978724, + "maxMean": 77.95705815614956, + "maxMeanConc": 1.6989700043360187, + "maxMed": 77.95705815614956, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 5, + "tmpi": 11, + "m5id": 5037058, + "modl": "hill", + "hitc": 0.9999986614193673, + "fitc": 41, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.22184874961635637, + -1.6989700043360187, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + 0.3010299956639812, + 1.6989700043360187 + ], + "resp": [ + 64.23854892075744, + -28.22028225978724, + 71.52551303778179, + -8.36715608785845, + 77.90911291815605, + 1.215720341597959, + 77.60553886175157, + 77.95705815614956 + ] + }, + "mc4Param": { + "pow_a": 30.822288131348024, + "pow_p": 0.3000004325120875, + "exp2_a": 9745.30422459993, + "exp2_b": 4985.4095456974865, + "exp3_a": 743.0734773552446, + "exp3_b": 48000.25079936882, + "exp3_p": 0.30036500057781645, + "exp5_p": 4.387719474863923, + "gnls_p": 5.312129658102232, + "gnls_q": 6.044467438794108, + "hill_p": 5.312112708921902, + "pow_er": 3.2500407355444447, + "cnst_er": 4.016143460737711, + "exp2_er": 3.6767003773089906, + "exp3_er": 3.320916603363695, + "exp4_er": 2.55983470322537, + "exp4_ga": 0.4227743529273414, + "exp4_tp": 77.51175315148927, + "exp5_er": 1.566158921380688, + "exp5_ga": 0.4808129543908409, + "exp5_tp": 76.49260417613746, + "gnls_er": 1.5661710124267216, + "gnls_ga": 0.43921987635195425, + "gnls_la": 3693.146065235527, + "gnls_tp": 76.49829109592685, + "hill_er": 1.56618318750266, + "hill_ga": 0.4392211414112244, + "hill_tp": 76.4982866415209, + "poly1_a": 1.964864684075168, + "poly2_a": 13315.496644004026, + "poly2_b": 6833.361453964935, + "pow_aic": 83.17121500215309, + "pow_cov": 1, + "pow_rme": 27.538007561894084, + "pow_top": 99.66819933343275, + "all_bmed": 0, + "cnst_aic": 91.47566405075946, + "cnst_rme": 59.45598607857977, + "exp2_aic": 90.43010743722112, + "exp2_cov": 1, + "exp2_rme": 44.39325952551422, + "exp2_top": 98.2300154558304, + "exp3_aic": 85.41740122713443, + "exp3_cov": 1, + "exp3_rme": 27.91524176610176, + "exp3_top": 100.72988078777028, + "exp4_aic": 73.1330171088266, + "exp4_cov": 1, + "exp4_rme": 15.554088816265924, + "exp4_top": 77.51175315148927, + "exp5_aic": 64.42879073216514, + "exp5_cov": 1, + "exp5_rme": 10.586877659593066, + "exp5_top": 76.49260417613746, + "gnls_aic": 68.42786525704236, + "gnls_cov": 1, + "gnls_rme": 10.586540812021129, + "gnls_top": 76.49829109470431, + "hill_aic": 64.42786525848331, + "hill_cov": 1, + "hill_rme": 10.58654076385496, + "hill_top": 76.4982866415209, + "poly1_er": 3.675479917703469, + "poly2_er": 3.6753004741857582, + "pow_a_sd": 14.109693155432794, + "pow_ac50": 4.960644811507054, + "pow_p_sd": 0.13040289753508288, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 95296.73353627026, + "exp2_ac50": 25.06268265173192, + "exp2_b_sd": 48443.778447988494, + "exp3_a_sd": 1550.6811753333395, + "exp3_ac50": 5.520304040411192, + "exp3_b_sd": 261983.9706240629, + "exp3_p_sd": 0.14665644781542486, + "exp4_ac50": 0.4227743529273414, + "exp5_ac50": 0.4808129543908409, + "exp5_p_sd": 3.3678395549353852, + "gnls_ac50": 0.4392198767408624, + "gnls_p_sd": 3.3958255218054663, + "gnls_q_sd": 151123.9464489836, + "hill_ac50": 0.4392211414112244, + "hill_p_sd": 3.3956061053853364, + "poly1_aic": 88.41948218774404, + "poly1_cov": 1, + "poly1_rme": 44.36648863230358, + "poly1_top": 98.2432342037584, + "poly2_aic": 90.43488820771466, + "poly2_cov": 1, + "poly2_rme": 44.40668518959494, + "poly2_top": 98.14296226438184, + "pow_er_sd": 0.30358860504155505, + "exp2_er_sd": 0.3103300882267534, + "exp3_er_sd": 0.31482864784179443, + "exp4_er_sd": 0.3265560847968896, + "exp4_ga_sd": 0.18734711782917823, + "exp4_tp_sd": 6.138860820650144, + "exp5_er_sd": 0.42334596392662655, + "exp5_ga_sd": 0.08381003754668022, + "exp5_tp_sd": 2.37147868048167, + "gnls_er_sd": 0.4232676288363896, + "gnls_ga_sd": 0.09134632329842142, + "gnls_la_sd": 397472143.96622753, + "gnls_tp_sd": 2.3747859083019507, + "hill_er_sd": 0.4232684668587263, + "hill_ga_sd": 0.09134005178183088, + "hill_tp_sd": 2.3748058180813865, + "poly1_a_sd": 0.744525928526376, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 108969.20708301498, + "poly2_ac50": 25.090797462838403, + "poly2_b_sd": 55447.95612242906, + "poly1_er_sd": 0.31021542326112006, + "poly2_er_sd": 0.3101964438666455, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 3693.146065255056 + }, + "mc5Param": { + "p": 5.312112708921902, + "er": 1.56618318750266, + "ga": 0.4392211414112244, + "tp": 76.4982866415209, + "ac5": 0.25232432887622686, + "acc": 0.37284383772523594, + "bmd": 0.3026161445689406, + "bmr": 9.289141683881516, + "mll": -28.213932629241658, + "top": 76.4982866415209, + "ac10": 0.2904343777444861, + "ac20": 0.3383343045279963, + "ac50": 0.4392211414112244, + "bmdl": 0.24652928226101983, + "bmdu": 0.34140137679409, + "rmse": 10.58654076385496, + "ac1sd": 0.28414838641852014, + "caikwt": 0.0000013385806326866767, + "hitcall": 0.9999986614193672, + "top_over_cutoff": 3.3877568980269706 + }, + "mc6Param": { + "flag": [ + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842413, + "spid": "Strychnine nitrate", + "chid": null, + "casn": null, + "chnm": null, + "dtxsid": null, + "bmad": 3.7634679299683276, + "respMax": 101.90302651672913, + "respMin": -13.656252398863883, + "maxMean": 90.10574793432083, + "maxMeanConc": 0.0, + "maxMed": 92.78949471220062, + "maxMedConc": 1.0, + "logcMax": 1.0, + "logcMin": -2.0, + "nconc": 5, + "npts": 120, + "nrep": 28.0, + "nmedGtbl": 4, + "tmpi": 12, + "m5id": 5037059, + "modl": "hill", + "hitc": 0.9999999999995097, + "fitc": 41, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": null, + "stkc": null, + "stkcUnit": null, + "testedConcUnit": null, + "mc3Param": { + "logc": [ + 0, + -1, + -1.3010299956639813, + -1.3010299956639813, + 0, + -2, + -1, + 1, + 1, + -2, + -2, + 0, + 0, + 0, + -2, + -2, + -2, + 0, + 0, + -2, + -1.3010299956639813, + 0, + 0, + -1, + -1.3010299956639813, + 1, + -2, + -1.3010299956639813, + -2, + 1, + -1.3010299956639813, + 0, + -1, + -1.3010299956639813, + 0, + -1, + -1.3010299956639813, + 1, + -2, + -1.3010299956639813, + 0, + -2, + -1.3010299956639813, + -1, + 0, + -2, + -1.3010299956639813, + 0, + -2, + -1.3010299956639813, + -1.3010299956639813, + 1, + -2, + 0, + 0, + -2, + -1.3010299956639813, + 0, + -1.3010299956639813, + -1, + -1.3010299956639813, + -2, + -1.3010299956639813, + 1, + -2, + 0, + 0, + -2, + -1.3010299956639813, + 0, + 0, + -1, + -2, + 0, + 0, + 0, + 0, + -2, + -2, + 0, + 0, + -1, + -1.3010299956639813, + 0, + -2, + -1.3010299956639813, + 1, + 0, + -1.3010299956639813, + 0, + -1, + 0, + 0, + -1, + -1.3010299956639813, + 1, + -2, + -1.3010299956639813, + -1.3010299956639813, + 1, + -2, + 0, + 1, + 0, + 0, + 1, + -2, + 0, + 0, + -2, + -2, + 0, + -1.3010299956639813, + 0, + 0, + -2, + -1, + -1.3010299956639813, + -1.3010299956639813, + -1.3010299956639813 + ], + "resp": [ + 87.54658046017934, + 78.13232047400955, + 70.93317595233076, + 57.12698428271491, + 99.1261742792355, + 37.51266678271632, + 67.39566754400876, + 87.16917249987551, + 97.84412575893514, + 36.182153851871945, + 18.676759780138298, + 86.14639524902825, + 92.14700970993877, + 88.8633754305396, + 52.588582215844326, + 15.582133819049302, + 6.7437112326760795, + 90.99910854039037, + 93.537388378317, + 4.532945470243127, + 98.29029571012077, + 87.5125820151942, + 95.77948529616398, + 76.69719021917145, + 79.44282282360146, + 93.41848845767122, + 43.82855649076092, + 60.078635480642816, + 48.55573840229915, + 93.38936767278678, + 68.38088898210545, + 94.44174081967034, + 70.23063280229242, + 67.58951070420052, + 88.25476716259126, + 78.28663544945115, + 73.35709503155529, + 87.41418530525512, + 34.29624566401982, + 51.689530650495065, + 94.77671619175891, + 9.717713327456835, + 68.42696208430887, + 89.1457018171264, + 98.63621639131843, + 21.819867325289668, + 73.31442418286787, + 84.44684859725044, + 101.90302651672913, + 52.3796866174266, + 76.70392442439466, + 95.96954413243368, + 37.932664452132045, + 85.53995501238715, + 93.19761923373274, + 9.374938681003872, + 97.00772826137256, + 94.52068000480857, + 70.03934960306947, + 70.2207854474335, + 80.60056702989422, + 49.65332555177622, + 50.62118183723142, + -13.656252398863883, + 25.103929419420417, + 84.06775274470809, + 93.89545097387872, + 13.05234184109041, + 68.04669508697455, + 88.31017585712213, + 95.74909219574056, + 71.26573270110495, + 29.657483179306475, + 89.44967487095494, + 87.91122190917191, + 89.16083809801721, + 94.23105830572473, + 11.031715473484446, + 35.95756511831335, + 83.96484285494779, + 91.13344836386635, + 74.37468254708669, + 75.90341444167755, + 84.57925357612386, + 98.09697348327087, + 80.87025230976089, + 95.69038769184029, + 88.16849658860856, + 80.80349695840118, + 81.03526087553716, + 70.7375590556676, + 89.62211351249503, + 92.83767649850626, + 69.7285258942436, + 77.48304372596083, + 85.86002702419643, + 32.2784448599929, + 46.17015103402697, + 80.62410063741106, + 95.95106666573619, + 10.20724914281911, + 79.02545835944098, + 87.98083471817364, + 91.89339887484604, + 95.37517669787248, + 92.18962175161448, + 25.413153770849384, + 85.26467195488401, + 94.339523858436, + 21.432040978539256, + 30.458993571633304, + 93.86466610169768, + 70.85250358307763, + 84.70694885833929, + 90.17107266940845, + 42.17348917186203, + 67.85218078295692, + 80.66923781410267, + 52.40470406123019, + 66.29938729985028 + ] + }, + "mc4Param": { + "pow_a": 87.09928260115939, + "pow_p": 0.30000001846938457, + "exp2_a": 31883.447199556984, + "exp2_b": 2940.8756880830274, + "exp3_a": 91.76407834702847, + "exp3_b": 10.74787786809403, + "exp3_p": 5.705870147581669, + "exp5_p": 0.7347141145071212, + "gnls_p": 1.14249184755643, + "gnls_q": 7.1666617485862645, + "hill_p": 1.1425173709866314, + "pow_er": 3.2609559647059276, + "cnst_er": 4.280418232198627, + "exp2_er": 4.136618684570908, + "exp3_er": 4.195352905645352, + "exp4_er": 2.22008241758199, + "exp4_ga": 0.022051638521133003, + "exp4_tp": 89.00270902788958, + "exp5_er": 2.1777043891985155, + "exp5_ga": 0.020174723818180185, + "exp5_tp": 90.09083963206248, + "gnls_er": 2.1414728444590416, + "gnls_ga": 0.019239355601206622, + "gnls_la": 152.60173969793468, + "gnls_tp": 90.96174103754969, + "hill_er": 2.141463902181826, + "hill_ga": 0.019239408518013583, + "hill_tp": 90.96158402591846, + "poly1_a": 10.857285554865078, + "poly2_a": 43956.72490990105, + "poly2_b": 4063.958522468021, + "pow_aic": 1201.4051365890562, + "pow_cov": 1, + "pow_rme": 38.55227695861075, + "pow_top": 173.78592362556904, + "all_bmed": 0, + "cnst_aic": 1403.090413337808, + "cnst_rme": 74.8904479807055, + "exp2_aic": 1374.4311656282052, + "exp2_cov": 1, + "exp2_rme": 65.81746775643614, + "exp2_top": 108.5993407555391, + "exp3_aic": 1391.1625030286802, + "exp3_cov": 1, + "exp3_rme": 70.11489384972245, + "exp3_top": 86.24941190716868, + "exp4_aic": 958.5585213667588, + "exp4_cov": 1, + "exp4_rme": 17.136859425351332, + "exp4_top": 89.00270902788958, + "exp5_aic": 951.462915769895, + "exp5_cov": 1, + "exp5_rme": 16.563670044171328, + "exp5_top": 90.09083963206248, + "gnls_aic": 949.1076392567716, + "gnls_cov": 1, + "gnls_rme": 16.523174598011288, + "gnls_top": 90.94223261829664, + "hill_aic": 945.1076391339816, + "hill_cov": 1, + "hill_rme": 16.52318715556179, + "hill_top": 90.96158402591846, + "poly1_er": 4.136728636883216, + "poly2_er": 4.136765485844394, + "pow_a_sd": null, + "pow_ac50": 0.9921257986045094, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 199788.2012717345, + "exp2_ac50": 5.004250432627864, + "exp2_b_sd": 18377.639690188746, + "exp3_a_sd": null, + "exp3_ac50": 9.093200201104786, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 0.022051638521133003, + "exp5_ac50": 0.020174723818180185, + "exp5_p_sd": 0.0740314724723753, + "gnls_ac50": 0.01923213377527789, + "gnls_p_sd": 0.11328716035704128, + "gnls_q_sd": 5416.430149594935, + "hill_ac50": 0.019239408518013583, + "hill_p_sd": 0.11328905952344805, + "poly1_aic": 1372.405512117827, + "poly1_cov": 1, + "poly1_rme": 65.81045931392097, + "poly1_top": 108.57285554865078, + "poly2_aic": 1374.4425868107508, + "poly2_cov": 1, + "poly2_rme": 65.82134141098302, + "poly2_top": 108.42848666577588, + "pow_er_sd": null, + "exp2_er_sd": 0.07550543011989125, + "exp3_er_sd": null, + "exp4_er_sd": 0.08755079994277236, + "exp4_ga_sd": 0.0017581307838751255, + "exp4_tp_sd": 1.2648745704125903, + "exp5_er_sd": 0.08793429019100046, + "exp5_ga_sd": 0.001896252806984504, + "exp5_tp_sd": 1.229548672184863, + "gnls_er_sd": 0.08841293445887041, + "gnls_ga_sd": 0.0016388070613483495, + "gnls_la_sd": 314310.1153126622, + "gnls_tp_sd": 1.3592077185077482, + "hill_er_sd": 0.08841259880190765, + "hill_ga_sd": 0.001638789350228368, + "hill_tp_sd": 1.3591867915855804, + "poly1_a_sd": 1.724413789883238, + "poly1_ac50": 5, + "poly2_a_sd": 229686.482934115, + "poly2_ac50": 5.006136528441479, + "poly2_b_sd": 21186.121669100652, + "poly1_er_sd": 0.07551023114530929, + "poly2_er_sd": 0.07551301062757607, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 152.6093800236882 + }, + "mc5Param": { + "p": 1.1425173709866314, + "er": 2.141463902181826, + "ga": 0.019239408518013583, + "tp": 90.96158402591846, + "ac5": 0.001462007378119528, + "acc": 0.007294932270379909, + "bmd": 0.002869845955059214, + "bmr": 9.289141683881516, + "mll": -468.55381956699074, + "top": 90.96158402591846, + "ac10": 0.0028117791882338312, + "ac20": 0.005717847375539592, + "ac50": 0.019239408518013583, + "bmdl": 0.002556132850019782, + "bmdu": 0.003219636919114361, + "rmse": 16.52318715556179, + "ac1sd": 0.0021529836063463184, + "caikwt": 3.550619862824629E-100, + "hitcall": 0.9999999999995096, + "top_over_cutoff": 4.028269746527992 + }, + "mc6Param": null + }, + { + "aeid": 704, + "m4id": 1842414, + "spid": "TP0000202A12", + "chid": 40755, + "casn": "113776-20-8", + "chnm": "Fenoxaprop-(2S)-ethyl", + "dtxsid": "DTXSID0040755", + "bmad": 3.7634679299683276, + "respMax": 2.1463056962554306, + "respMin": -31.174537622350467, + "maxMean": 2.1463056962554306, + "maxMeanConc": 0.3010299956639812, + "maxMed": 2.1463056962554306, + "maxMedConc": 0.3010299956639812, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 13, + "m5id": 5037060, + "modl": "poly1", + "hitc": 3.112525321590652E-4, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.22184874961635637, + 1.6989700043360187, + 0.3010299956639812, + -1.6989700043360187, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187 + ], + "resp": [ + -6.001541932753394, + -22.555888323094198, + 2.1463056962554306, + 1.48208851017487, + -31.174537622350467, + -1.4820885101748698, + -18.65401670786573, + -1.8956068394961023 + ] + }, + "mc4Param": { + "pow_a": 7.93772851385601E-8, + "pow_p": 0.3920636582682493, + "exp2_a": 0.000006112271332380458, + "exp2_b": 53.427073060892454, + "exp3_a": 0.00004898139853742899, + "exp3_b": 51.88258897771602, + "exp3_p": 2.324270887717195, + "exp5_p": 0.7819736441489689, + "gnls_p": 0.3273711734771393, + "gnls_q": 5.276277742389474, + "hill_p": 2.275897186558642, + "pow_er": 2.455992402942634, + "cnst_er": 2.4560891502518984, + "exp2_er": 2.4574807100236153, + "exp3_er": 2.4557796019426146, + "exp4_er": 2.456099699774736, + "exp4_ga": 2.3234618330958865, + "exp4_tp": 3.9607133152532646E-9, + "exp5_er": 2.4560842486541183, + "exp5_ga": 3.1011214463834262, + "exp5_tp": 5.124637982443043E-9, + "gnls_er": 2.45606236272885, + "gnls_ga": 2.0776018550817037, + "gnls_la": 105.43975814448936, + "gnls_tp": 2.3963648893966506E-8, + "hill_er": 2.456123173511501, + "hill_ga": 86.3108381026584, + "hill_tp": 4.991236675789709E-8, + "poly1_a": 5.0558047407700206E-11, + "poly2_a": 0.000050849272267483245, + "poly2_b": 54.52806494231579, + "pow_aic": 72.32793038983723, + "pow_cov": 1, + "pow_rme": 15.318305641270856, + "pow_top": 3.6796002210498555E-7, + "all_bmed": 0, + "cnst_aic": 68.32793015445507, + "cnst_rme": 15.318305491530715, + "exp2_aic": 72.32794851195803, + "exp2_cov": 1, + "exp2_rme": 15.318307841595969, + "exp2_top": 0.00000947030777995316, + "exp3_aic": 74.32794792480452, + "exp3_cov": 1, + "exp3_rme": 15.318319988232922, + "exp3_top": 0.00007364243647945785, + "exp4_aic": 72.32793015872747, + "exp4_cov": 1, + "exp4_rme": 15.318305493705283, + "exp4_top": 3.9607133152532646E-9, + "exp5_aic": 74.32793015704087, + "exp5_cov": 1, + "exp5_rme": 15.31830549412419, + "exp5_top": 5.124637982443043E-9, + "gnls_aic": 78.32793016843104, + "gnls_cov": 1, + "gnls_rme": 15.31830550116845, + "gnls_top": 1.7376669540347054E-8, + "hill_aic": 74.32793016978079, + "hill_cov": 1, + "hill_rme": 15.318305493880896, + "hill_top": 4.991236675789709E-8, + "poly1_er": 2.456091603321706, + "poly2_er": 2.458795669607504, + "pow_a_sd": null, + "pow_ac50": 8.534164879531097, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 30.647334567122023, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 40.44683070951887, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 2.3234618330958865, + "exp5_ac50": 3.1011214463834262, + "exp5_p_sd": null, + "gnls_ac50": 0.3706914715054184, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 86.3108381026584, + "hill_p_sd": null, + "poly1_aic": 70.32793015555615, + "poly1_cov": 1, + "poly1_rme": 15.31830549222699, + "poly1_top": 2.5279023703850103E-9, + "poly2_aic": 72.32801460829577, + "poly2_cov": 1, + "poly2_rme": 15.318327400684396, + "poly2_top": 0.00008938146834261408, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": null, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.67152733580562, + "poly2_b_sd": null, + "poly1_er_sd": null, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 108.5387707140687 + }, + "mc5Param": { + "a": 5.0558047407700206E-11, + "er": 2.456091603321706, + "ac5": 2.4999999999999996, + "bmd": 183732208029.59137, + "bmr": 9.289141683881516, + "mll": -33.16396507777807, + "top": 2.5279023703850103E-9, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 55.118208071787095, + "rmse": 15.31830549222699, + "ac1sd": 136198819888.5036, + "caikwt": 0.7310585787382466, + "hitcall": 0.0003112525321590652, + "top_over_cutoff": 1.1194915688689839E-10 + }, + "mc6Param": { + "flag": [ + "Model directionality questionable", + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 5, + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842415, + "spid": "TP0000202E12", + "chid": 32488, + "casn": "117718-60-2", + "chnm": "Thiazopyr", + "dtxsid": "DTXSID1032488", + "bmad": 3.7634679299683276, + "respMax": 6.446936756495938, + "respMin": -27.99639047559999, + "maxMean": 6.446936756495938, + "maxMeanConc": -0.6989700043360187, + "maxMed": 6.446936756495938, + "maxMedConc": -0.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 14, + "m5id": 5037061, + "modl": "poly1", + "hitc": 3.46254861405938E-4, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.22184874961635637, + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + -1.6989700043360187, + 1.6989700043360187, + 1.3010299956639813, + -0.6989700043360187 + ], + "resp": [ + 2.3401929572491063, + -9.617064235516741, + -24.581899003404654, + -5.427697641004625, + 5.427697641004625, + -9.142353819653172, + -27.99639047559999, + 6.446936756495938 + ] + }, + "mc4Param": { + "pow_a": 8.291778304541115E-8, + "pow_p": 0.759489844462891, + "exp2_a": 0.000005100967135478326, + "exp2_b": 66.78668129818874, + "exp3_a": 0.00000795052649415302, + "exp3_b": 59.8550913973304, + "exp3_p": 6.3695090638042515, + "exp5_p": 2.1989554286217405, + "gnls_p": 7.325020891066998, + "gnls_q": 7.999920644098824, + "hill_p": 5.230822870987461, + "pow_er": 2.4449412532586106, + "cnst_er": 2.444612267004776, + "exp2_er": 2.4454237030104045, + "exp3_er": 2.4444001292182183, + "exp4_er": 2.4446018093199684, + "exp4_ga": 5.268966164997101, + "exp4_tp": 2.503020809468994E-9, + "exp5_er": 2.4445975509803857, + "exp5_ga": 4.6875957305191935, + "exp5_tp": 1.1081629207669447E-9, + "gnls_er": 2.4231904512610143, + "gnls_ga": 0.004416803248006645, + "gnls_la": 0.82966745174129, + "gnls_tp": 2.40116151835256, + "hill_er": 2.444611179532325, + "hill_ga": 142.56639582523107, + "hill_tp": 0.00006917638723040847, + "poly1_a": 4.602316355764391E-10, + "poly2_a": 0.000012228970875458648, + "poly2_b": 51.825063680254665, + "pow_aic": 71.6355163848002, + "pow_cov": 1, + "pow_rme": 14.448605421396229, + "pow_top": 0.0000016180731311326594, + "all_bmed": 0, + "cnst_aic": 67.63551484073298, + "cnst_rme": 14.44860501974752, + "exp2_aic": 71.63552232788017, + "exp2_cov": 1, + "exp2_rme": 14.448606013868249, + "exp2_top": 0.000005683236291608053, + "exp3_aic": 73.63551565609121, + "exp3_cov": 1, + "exp3_rme": 14.448605256905164, + "exp3_top": 0.0000029758177359879932, + "exp4_aic": 71.63551484106912, + "exp4_cov": 1, + "exp4_rme": 14.448605020839846, + "exp4_top": 2.503020809468994E-9, + "exp5_aic": 73.63551484062032, + "exp5_cov": 1, + "exp5_rme": 14.448605020276853, + "exp5_top": 1.1081629207669447E-9, + "gnls_aic": 77.44750709660826, + "gnls_cov": 1, + "gnls_rme": 14.365799933750845, + "gnls_top": 2.401161508659121, + "hill_aic": 73.6355148837213, + "hill_cov": 1, + "hill_rme": 14.448605043026824, + "hill_top": 0.00006917638723040847, + "poly1_er": 2.444589406786654, + "poly2_er": 2.4442589836933477, + "pow_a_sd": null, + "pow_ac50": 20.072979750096557, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 29.57372140444595, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 45.38400488151858, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 5.268966164997101, + "exp5_ac50": 4.6875957305191935, + "exp5_p_sd": null, + "gnls_ac50": 0.004416803145331396, + "gnls_p_sd": 1521.0342465884344, + "gnls_q_sd": 78.00215408532839, + "hill_ac50": 142.56639582523107, + "hill_p_sd": null, + "poly1_aic": 69.63551484744472, + "poly1_cov": 1, + "poly1_rme": 14.448605024451211, + "poly1_top": 2.3011581778821953E-8, + "poly2_aic": 71.63552116107905, + "poly2_cov": 1, + "poly2_rme": 14.448608809150656, + "poly2_top": 0.0000231811467637089, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": 0.33687191979010667, + "gnls_ga_sd": 1.384790805886578, + "gnls_la_sd": 4.751505700203281, + "gnls_tp_sd": 5.895901623091699, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.4194146457345064, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.8068290375481, + "poly2_b_sd": null, + "poly1_er_sd": 0.5297759747014638, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.8296674525635499 + }, + "mc5Param": { + "a": 4.602316355764391E-10, + "er": 2.444589406786654, + "ac5": 2.5, + "bmd": 20183622693.053, + "bmr": 9.289141683881516, + "mll": -32.81775742372236, + "top": 2.3011581778821953E-8, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 51.81424943318225, + "rmse": 14.448605024451211, + "ac1sd": 14961914524.131208, + "caikwt": 0.7310585792898094, + "hitcall": 0.000346254861405938, + "top_over_cutoff": 1.0190770058816301E-9 + }, + "mc6Param": { + "flag": [ + "Model directionality questionable", + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 5, + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842416, + "spid": "TP0000267A05", + "chid": 20605, + "casn": "104-76-7", + "chnm": "2-Ethyl-1-hexanol", + "dtxsid": "DTXSID5020605", + "bmad": 3.7634679299683276, + "respMax": 8.917578703786559, + "respMin": -27.524983015647525, + "maxMean": 8.917578703786559, + "maxMeanConc": 1.3010299956639813, + "maxMed": 8.917578703786559, + "maxMedConc": 1.3010299956639813, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 15, + "m5id": 5037062, + "modl": "poly1", + "hitc": 2.7345343716299954E-4, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 1.3010299956639813, + -0.22184874961635637, + 1.6989700043360187, + 0.3010299956639812, + -1.6989700043360187, + 0.7781512503836436, + -1.154901959985743, + -0.6989700043360187 + ], + "resp": [ + 8.917578703786559, + 2.303464923343869, + -2.654003487492171, + 5.234355203561155, + -1.2708393819946822, + 3.560451307578698, + 1.2708393819946822, + -27.524983015647525 + ] + }, + "mc4Param": { + "pow_a": 1.3409798272664342, + "pow_p": 0.30000125329590954, + "exp2_a": 0.000009166742411061137, + "exp2_b": 71.96205294539993, + "exp3_a": 0.00006076828394343419, + "exp3_b": 62.86725328613552, + "exp3_p": 7.737091326965924, + "exp5_p": 7.999225969557049, + "gnls_p": 7.999875866687627, + "gnls_q": 7.928505491369158, + "hill_p": 7.999295227329135, + "pow_er": 1.6343827564280675, + "cnst_er": 1.7486670966982418, + "exp2_er": 1.747752679520703, + "exp3_er": 1.7491987890837994, + "exp4_er": 1.4661518060319405, + "exp4_ga": 0.5858515967961853, + "exp4_tp": 4.070715215170674, + "exp5_er": 1.4537496560481071, + "exp5_ga": 0.5879387517028682, + "exp5_tp": 4.129989453625999, + "gnls_er": 1.453809084181787, + "gnls_ga": 0.5829865127961461, + "gnls_la": 2656.355330614829, + "gnls_tp": 4.13074242306633, + "hill_er": 1.453742415592828, + "hill_ga": 0.582943689295207, + "hill_tp": 4.130157183529929, + "poly1_a": 0.006514257261741929, + "poly2_a": 0.000027619479202203845, + "poly2_b": 55.994704795242086, + "pow_aic": 62.72267287754171, + "pow_cov": 1, + "pow_rme": 10.626636623495806, + "pow_top": 4.336260608140496, + "all_bmed": 0, + "cnst_aic": 59.54309904759475, + "cnst_rme": 10.564107501908008, + "exp2_aic": 63.54310497598492, + "exp2_cov": 1, + "exp2_rme": 10.564107437382722, + "exp2_top": 0.000009197264782794135, + "exp3_aic": 65.54310319994451, + "exp3_cov": 1, + "exp3_rme": 10.564107854679628, + "exp3_top": 0.000011262424950383531, + "exp4_aic": 61.53985639831838, + "exp4_cov": 1, + "exp4_rme": 10.486648481057117, + "exp4_top": 4.070715215170674, + "exp5_aic": 63.21877166657443, + "exp5_cov": 1, + "exp5_rme": 10.19418095478504, + "exp5_top": 4.129989453625999, + "gnls_aic": 67.21889618297809, + "gnls_cov": 1, + "gnls_rme": 10.194291475779997, + "gnls_top": 4.130742423066309, + "hill_aic": 63.218896291500144, + "hill_cov": 1, + "hill_rme": 10.194281256916245, + "hill_top": 4.130157183529929, + "poly1_er": 1.7507922358775536, + "poly2_er": 1.749512892071607, + "pow_a_sd": 3.295794305479151, + "pow_ac50": 4.960676169539393, + "pow_p_sd": 0.5672534752096554, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 29.2579276272496, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 45.9617423857624, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 0.5858515967961853, + "exp5_ac50": 0.5879387517028682, + "exp5_p_sd": 98.74044274222942, + "gnls_ac50": 0.5829865133961057, + "gnls_p_sd": 74.31411976207677, + "gnls_q_sd": 6357704.376873938, + "hill_ac50": 0.582943689295207, + "hill_p_sd": 74.30108138165775, + "poly1_aic": 61.53965299852143, + "poly1_cov": 1, + "poly1_rme": 10.559185088231294, + "poly1_top": 0.3257128630870964, + "poly2_aic": 63.543106176613115, + "poly2_cov": 1, + "poly2_rme": 10.564107377657889, + "poly2_top": 0.00004668482556197718, + "pow_er_sd": 0.4819729825595672, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": 0.42833896312172504, + "exp4_ga_sd": 1.0334925947270197, + "exp4_tp_sd": 2.6528735376099615, + "exp5_er_sd": 0.42414936250544655, + "exp5_ga_sd": 0.2459821670424215, + "exp5_tp_sd": 2.444384508491113, + "gnls_er_sd": 0.42415640100500435, + "gnls_ga_sd": 0.32464475146069505, + "gnls_la_sd": 8816666864.83012, + "gnls_tp_sd": 2.4443852082427937, + "hill_er_sd": 0.4241479766226494, + "hill_ga_sd": 0.32494411453400046, + "hill_tp_sd": 2.4443739248424277, + "poly1_a_sd": 0.11187540886288934, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.600594333963585, + "poly2_b_sd": null, + "poly1_er_sd": 0.3807131709053242, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 2656.355330614833 + }, + "mc5Param": { + "a": 0.006514257261741929, + "er": 1.7507922358775536, + "ac5": 2.4999999999999996, + "bmd": 1425.9709604096254, + "bmr": 9.289141683881516, + "mll": -28.769826499260716, + "top": 0.3257128630870964, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 35.11258847587849, + "rmse": 10.559185088231294, + "ac1sd": 1057.0577912599151, + "caikwt": 0.7307196766051358, + "hitcall": 0.00027345343716299954, + "top_over_cutoff": 0.014424323042295618 + }, + "mc6Param": { + "flag": [ + "Model directionality questionable", + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 5, + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842417, + "spid": "TP0000267B05", + "chid": 34287, + "casn": "104-67-6", + "chnm": "5-Heptyldihydro-2(3H)-furanone", + "dtxsid": "DTXSID4034287", + "bmad": 3.7634679299683276, + "respMax": 2.5626891439251516, + "respMin": -8.146024449386633, + "maxMean": 2.5626891439251516, + "maxMeanConc": -1.6989700043360187, + "maxMed": 2.5626891439251516, + "maxMedConc": -1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 16, + "m5id": 5037063, + "modl": "poly1", + "hitc": 1.807739510130505E-7, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 1.3010299956639813, + -0.22184874961635637, + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + -1.6989700043360187, + 1.6989700043360187, + -0.6989700043360187 + ], + "resp": [ + -6.177917513479251, + -7.198652565084555, + -8.146024449386633, + -6.691171080481884, + -2.56268914392515, + 2.5626891439251516, + -2.808406691690573, + -1.4980285452563038 + ] + }, + "mc4Param": { + "pow_a": 5.2359519867188026E-8, + "pow_p": 0.38277275314144577, + "exp2_a": 0.000011087622110252254, + "exp2_b": 59.03037755815387, + "exp3_a": 0.000011323074766607115, + "exp3_b": 58.09532026397317, + "exp3_p": 3.173411562559084, + "exp5_p": 1.8704058411614604, + "gnls_p": 4.0745292599201, + "gnls_q": 7.9950187264172525, + "hill_p": 3.453820607013757, + "pow_er": 1.5839659163624915, + "cnst_er": 1.5838738330644857, + "exp2_er": 1.5830676537547204, + "exp3_er": 1.5842203728625608, + "exp4_er": 1.583875903464905, + "exp4_ga": 2.6417915753408012, + "exp4_tp": 1.5063871691541615E-9, + "exp5_er": 1.5838758461193252, + "exp5_ga": 1.4518069133691405, + "exp5_tp": 5.003350528655981E-10, + "gnls_er": 1.569937001781506, + "gnls_ga": 0.002000000005206344, + "gnls_la": 0.06324555337954348, + "gnls_tp": 1.6871203757458295, + "hill_er": 1.5838672292493845, + "hill_ga": 0.0032734995034449416, + "hill_tp": 1.5616538074162555E-9, + "poly1_a": 4.100095671825759E-11, + "poly2_a": 0.000003605359587272573, + "poly2_b": 56.69107597259129, + "pow_aic": 56.66259887682483, + "pow_cov": 1, + "pow_rme": 5.2960214297578565, + "pow_top": 2.3405346854235685E-7, + "all_bmed": 0, + "cnst_aic": 52.66259853073265, + "cnst_rme": 5.296021351915426, + "exp2_aic": 56.66261266299513, + "exp2_cov": 1, + "exp2_rme": 5.2960232653217565, + "exp2_top": 0.000014776347844907314, + "exp3_aic": 58.662602705894976, + "exp3_cov": 1, + "exp3_rme": 5.296022056507032, + "exp3_top": 0.00000974958415866995, + "exp4_aic": 56.662598532902635, + "exp4_cov": 1, + "exp4_rme": 5.296021352581836, + "exp4_top": 1.5063871691541615E-9, + "exp5_aic": 58.662598531608296, + "exp5_cov": 1, + "exp5_rme": 5.296021352180456, + "exp5_top": 5.003350528655981E-10, + "gnls_aic": 62.508666224566085, + "gnls_cov": 1, + "gnls_rme": 5.262039104915749, + "gnls_top": 1.686834446740104, + "hill_aic": 58.66259853487741, + "hill_cov": 1, + "hill_rme": 5.296021353114272, + "hill_top": 1.5616538074162555E-9, + "poly1_er": 1.5838907558030877, + "poly2_er": 1.584058977857187, + "pow_a_sd": null, + "pow_ac50": 8.175687415188362, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 30.142811088618416, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 42.03157273784789, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 2.6417915753408012, + "exp5_ac50": 1.4518069133691405, + "exp5_p_sd": null, + "gnls_ac50": 0.0019998336398390293, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 0.0032734995034449416, + "hill_p_sd": null, + "poly1_aic": 54.6625985350956, + "poly1_cov": 1, + "poly1_rme": 5.296021352230097, + "poly1_top": 2.050047835912879E-9, + "poly2_aic": 56.6626016317032, + "poly2_cov": 1, + "poly2_rme": 5.296022098645178, + "poly2_top": 0.000005984354139645306, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.12305820350276302, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.56750321043185, + "poly2_b_sd": null, + "poly1_er_sd": 0.387494804373577, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.06324822341628866 + }, + "mc5Param": { + "a": 4.100095671825759E-11, + "er": 1.5838907558030877, + "ac5": 2.4999999999999996, + "bmd": 226559144649.05865, + "bmr": 9.289141683881516, + "mll": -25.3312992675478, + "top": 2.050047835912879E-9, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 116.03234310631164, + "rmse": 5.296021352230097, + "ac1sd": 167945993068.24213, + "caikwt": 0.7310585790589084, + "hitcall": 1.807739510130505E-7, + "top_over_cutoff": 9.078717971742852E-11 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842418, + "spid": "TP0000267C07", + "chid": 26525, + "casn": "88-18-6", + "chnm": "2-tert-Butylphenol", + "dtxsid": "DTXSID2026525", + "bmad": 3.7634679299683276, + "respMax": 4.284991950831092, + "respMin": -17.752010560601963, + "maxMean": 4.284991950831092, + "maxMeanConc": -0.6989700043360187, + "maxMed": 4.284991950831092, + "maxMedConc": -0.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 17, + "m5id": 5037064, + "modl": "poly1", + "hitc": 1.080834578284038E-4, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + 1.6989700043360187, + -0.22184874961635637, + -1.6989700043360187, + 0.3010299956639812, + 0.7781512503836436 + ], + "resp": [ + -3.429511618336063, + -10.303773152544004, + 4.284991950831092, + -17.752010560601963, + -11.184188881006792, + 3.429511618336063, + -11.946623245214802, + -14.030114108296962 + ] + }, + "mc4Param": { + "pow_a": 1.1688027459778409E-7, + "pow_p": 0.3542167430597227, + "exp2_a": 0.00001402914266781098, + "exp2_b": 62.43720598776625, + "exp3_a": 8.518851392561705E-7, + "exp3_b": 55.14935347186949, + "exp3_p": 5.08068979673058, + "exp5_p": 0.934648289336587, + "gnls_p": 5.502938821699771, + "gnls_q": 7.707236696501689, + "hill_p": 1.330809264220454, + "pow_er": 2.294643719896335, + "cnst_er": 2.294672403578953, + "exp2_er": 2.2949759846580298, + "exp3_er": 2.2939792210930836, + "exp4_er": 2.2946893862543956, + "exp4_ga": 1.6265408298714532, + "exp4_tp": 1.7029436841556618E-10, + "exp5_er": 2.294667883086028, + "exp5_ga": 9.989504833632218, + "exp5_tp": 1.1382103679305392E-9, + "gnls_er": 2.2946723713323243, + "gnls_ga": 0.04465268081832286, + "gnls_la": 1.4750833148086038, + "gnls_tp": 9.842124013532871E-9, + "hill_er": 2.294684574430046, + "hill_ga": 113.24013298211491, + "hill_tp": 3.8147986424229266E-8, + "poly1_a": 1.930068017745631E-10, + "poly2_a": 0.000008995913833305391, + "poly2_b": 60.79500343541555, + "pow_aic": 68.01728590637344, + "pow_cov": 1, + "pow_rme": 10.769388915092584, + "pow_top": 4.672451958820215E-7, + "all_bmed": 0, + "cnst_aic": 64.01728561110329, + "cnst_rme": 10.769388711778616, + "exp2_aic": 68.01729252056795, + "exp2_cov": 1, + "exp2_rme": 10.769393202636683, + "exp2_top": 0.000017218419324428374, + "exp3_aic": 70.01729110083275, + "exp3_cov": 1, + "exp3_rme": 10.769388859159086, + "exp3_top": 7.124009276524897E-7, + "exp4_aic": 68.01728561547779, + "exp4_cov": 1, + "exp4_rme": 10.769388711877632, + "exp4_top": 1.7029436841556618E-10, + "exp5_aic": 70.01728561164555, + "exp5_cov": 1, + "exp5_rme": 10.769388712196594, + "exp5_top": 1.1382103679305392E-9, + "gnls_aic": 74.01728561314724, + "gnls_cov": 1, + "gnls_rme": 10.769388713041575, + "gnls_top": 9.841866233302444E-9, + "hill_aic": 70.0172856168267, + "hill_cov": 1, + "hill_rme": 10.769388714323313, + "hill_top": 3.8147986424229266E-8, + "poly1_er": 2.2946661884606754, + "poly2_er": 2.2951725166659296, + "pow_a_sd": null, + "pow_ac50": 7.065178187371053, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 29.87674555498022, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 44.83746128233124, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 1.6265408298714532, + "exp5_ac50": 9.989504833632218, + "exp5_p_sd": null, + "gnls_ac50": 0.04465225444658185, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 113.24013298211491, + "hill_p_sd": null, + "poly1_aic": 66.01728561475585, + "poly1_cov": 1, + "poly1_rme": 10.769388714484304, + "poly1_top": 9.650340088728157E-9, + "poly2_aic": 68.01729292719538, + "poly2_cov": 1, + "poly2_rme": 10.769392172059073, + "poly2_top": 0.000013483408486187177, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": 0.29967162033605704, + "exp4_ga_sd": 2.700161867338397, + "exp4_tp_sd": 0.000018830151796886426, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": null, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.379822973030592, + "poly2_b_sd": null, + "poly1_er_sd": null, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 1.475093338726149 + }, + "mc5Param": { + "a": 1.930068017745631E-10, + "er": 2.2946661884606754, + "ac5": 2.4999999999999996, + "bmd": 48128571627.913246, + "bmr": 9.289141683881516, + "mll": -31.008642807377925, + "top": 9.650340088728157E-9, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 64.94939269971773, + "rmse": 10.769388714484304, + "ac1sd": 35677221369.839325, + "caikwt": 0.7310585789890732, + "hitcall": 0.0001080834578284038, + "top_over_cutoff": 4.2736912994009806E-10 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842419, + "spid": "TP0000267C12", + "chid": 21217, + "casn": "58-14-0", + "chnm": "Pyrimethamine", + "dtxsid": "DTXSID9021217", + "bmad": 3.7634679299683276, + "respMax": 27.43198135493239, + "respMin": -9.573031880730055, + "maxMean": 27.43198135493239, + "maxMeanConc": 1.6989700043360187, + "maxMed": 27.43198135493239, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 4, + "tmpi": 18, + "m5id": 5037065, + "modl": "exp5", + "hitc": 0.9993015893938282, + "fitc": 42, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -1.6989700043360187, + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + -0.22184874961635637, + 0.3010299956639812, + 1.6989700043360187, + 0.7781512503836436 + ], + "resp": [ + -1.3626102221550411, + 1.362610222155042, + 26.100011514016813, + 5.083220148547186, + -9.573031880730055, + 12.263055448994821, + 27.43198135493239, + 19.028440712908623 + ] + }, + "mc4Param": { + "pow_a": 8.615918330641122, + "pow_p": 0.3256460648100804, + "exp2_a": 5515.924011580759, + "exp2_b": 8569.91582576029, + "exp3_a": 190.5815796850594, + "exp3_b": 18144.73145449149, + "exp3_p": 0.32098963519530016, + "exp5_p": 0.6697053366805052, + "gnls_p": 0.8182614183023493, + "gnls_q": 6.583211395264323, + "hill_p": 0.8182571770652887, + "pow_er": 1.363988503208183, + "cnst_er": 2.6252428146846465, + "exp2_er": 2.109704617961689, + "exp3_er": 1.5388722444020404, + "exp4_er": 0.9165567589387242, + "exp4_ga": 2.8867935103137805, + "exp4_tp": 26.682134872783596, + "exp5_er": 0.4118882359089413, + "exp5_ga": 2.6834018978246137, + "exp5_tp": 27.76803833586464, + "gnls_er": 0.5050076143816886, + "gnls_ga": 3.278943112805881, + "gnls_la": 4931.293978658584, + "gnls_tp": 30.974706420358636, + "hill_er": 0.5049887009187453, + "hill_ga": 3.2789253729229126, + "hill_tp": 30.974702991700216, + "poly1_a": 0.6448409372956132, + "poly2_a": 7685.079924681028, + "poly2_b": 11973.64247334707, + "pow_aic": 56.39160653523915, + "pow_cov": 1, + "pow_rme": 6.526761203406884, + "pow_top": 30.80097539574928, + "all_bmed": 0, + "cnst_aic": 69.92173854270355, + "cnst_rme": 16.07553951933683, + "exp2_aic": 65.29200171582212, + "exp2_cov": 1, + "exp2_rme": 9.191283585871052, + "exp2_top": 32.27596638509631, + "exp3_aic": 58.79084317495332, + "exp3_cov": 1, + "exp3_rme": 6.506169486296934, + "exp3_top": 31.014883737948537, + "exp4_aic": 50.88878665018997, + "exp4_cov": 1, + "exp4_rme": 4.969757377064164, + "exp4_top": 26.682134872783596, + "exp5_aic": 50.77303496851002, + "exp5_cov": 1, + "exp5_rme": 5.679144326208646, + "exp5_top": 27.76803833586464, + "gnls_aic": 55.27492786162859, + "gnls_cov": 1, + "gnls_rme": 5.673955293548314, + "gnls_top": 30.762420047102612, + "hill_aic": 51.27492786216142, + "hill_cov": 1, + "hill_rme": 5.6739736678642325, + "hill_top": 30.974702991700216, + "poly1_er": 2.108328509307753, + "poly2_er": 2.108918234235728, + "pow_a_sd": 1.9065377706614512, + "pow_ac50": 5.950610001585547, + "pow_p_sd": 0.06581177305373388, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 54261.41693977886, + "exp2_ac50": 25.03646471717236, + "exp2_b_sd": 83920.69797802145, + "exp3_a_sd": 319.30330931872754, + "exp3_ac50": 6.473920870323869, + "exp3_b_sd": 71486.21897878859, + "exp3_p_sd": 0.089062666508518, + "exp4_ac50": 2.8867935103137805, + "exp5_ac50": 2.6834018978246137, + "exp5_p_sd": 0.11428693722103664, + "gnls_ac50": 3.224472657149256, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 3.2789253729229126, + "hill_p_sd": 0.21665202304453965, + "poly1_aic": 63.28151185739537, + "poly1_cov": 1, + "poly1_rme": 9.185966970005357, + "poly1_top": 32.242046864780654, + "poly2_aic": 65.29643872279352, + "poly2_cov": 1, + "poly2_rme": 9.195851294815698, + "poly2_top": 32.22566397929895, + "pow_er_sd": 0.3611517914109552, + "exp2_er_sd": 0.3104544270600404, + "exp3_er_sd": 0.3808951094369049, + "exp4_er_sd": 0.3893880417326298, + "exp4_ga_sd": 0.8092255223155269, + "exp4_tp_sd": 1.7181047521648634, + "exp5_er_sd": 0.4652947689906473, + "exp5_ga_sd": 0.5440220897387579, + "exp5_tp_sd": 1.4682435434842378, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.44727516724237865, + "hill_ga_sd": 1.168035860526126, + "hill_tp_sd": 3.400651941209022, + "poly1_a_sd": 0.16629458913826986, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 63485.654673403085, + "poly2_ac50": 25.051980695483746, + "poly2_b_sd": 98453.01686169056, + "poly1_er_sd": 0.3103337077565139, + "poly2_er_sd": 0.31046879681961925, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 4937.830903270403 + }, + "mc5Param": { + "p": 0.6697053366805052, + "er": 0.4118882359089413, + "ga": 2.6834018978246137, + "tp": 27.76803833586464, + "ac5": 0.05498375432560493, + "acc": 10.043861366765938, + "bmd": 1.2128892362955723, + "bmr": 9.289141683881516, + "mll": -21.38651748425501, + "top": 27.76803833586464, + "ac10": 0.16107667754826716, + "ac20": 0.4939400347473494, + "ac50": 2.6834018978246137, + "bmdl": 0.949215313715193, + "bmdu": 1.5372925871551637, + "rmse": 5.679144326208646, + "ac1sd": 0.7117500271731652, + "caikwt": 0.00006948349796016499, + "hitcall": 0.9993015893938282, + "top_over_cutoff": 1.2297185668723691 + }, + "mc6Param": { + "flag": [ + "Average number of replicates per conc is less than 2", + "Less than 50% efficacy" + ], + "mc6MthdId": [ + 13, + 17 + ] + } + }, + { + "aeid": 704, + "m4id": 1842420, + "spid": "TP0000267E12", + "chid": 21311, + "casn": "732-26-3", + "chnm": "2,4,6-Tris(tert-butyl)phenol", + "dtxsid": "DTXSID2021311", + "bmad": 3.7634679299683276, + "respMax": 2.3455034490210025, + "respMin": -8.881536046239422, + "maxMean": 2.3455034490210025, + "maxMeanConc": -1.6989700043360187, + "maxMed": 2.3455034490210025, + "maxMedConc": -1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 19, + "m5id": 5037066, + "modl": "poly1", + "hitc": 2.529472360487395E-7, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + 1.6989700043360187, + -0.22184874961635637, + -1.6989700043360187 + ], + "resp": [ + -3.6871319675490226, + -8.202809310965216, + -2.3455034490210025, + -8.881536046239422, + 0.7714118421935772, + -3.442445468033866, + -8.217215474183769, + 2.3455034490210025 + ] + }, + "mc4Param": { + "pow_a": 4.4603222633107216E-8, + "pow_p": 0.3980715850861712, + "exp2_a": 0.00001500803162618182, + "exp2_b": 72.63641229778418, + "exp3_a": 0.000025895984061395693, + "exp3_b": 53.44323652739063, + "exp3_p": 6.684140439183912, + "exp5_p": 2.7549650881782495, + "gnls_p": 0.3000033566349074, + "gnls_q": 7.985201719769872, + "hill_p": 1.3414224872456235, + "pow_er": 1.6007569268879631, + "cnst_er": 1.600789396957988, + "exp2_er": 1.6013100926069517, + "exp3_er": 1.6012445517694611, + "exp4_er": 1.6007994489950037, + "exp4_ga": 1.8057489415221024, + "exp4_tp": 5.397987738417918E-10, + "exp5_er": 1.60079357288877, + "exp5_ga": 1.7684454448433695, + "exp5_tp": 8.377821726470055E-10, + "gnls_er": 1.5999160615939398, + "gnls_ga": 0.009427709959484824, + "gnls_la": 0.2982914089167051, + "gnls_tp": 0.2960388226873033, + "hill_er": 1.6007857351745025, + "hill_ga": 0.21326314555729145, + "hill_tp": 8.179987554374146E-10, + "poly1_a": 1.665857611967683E-11, + "poly2_a": 0.000003342211026439361, + "poly2_b": 54.331449188426035, + "pow_aic": 57.26619984359718, + "pow_cov": 1, + "pow_rme": 5.598366077511932, + "pow_top": 2.1167907095144258E-7, + "all_bmed": 0, + "cnst_aic": 53.26619960913695, + "cnst_rme": 5.598366003993902, + "exp2_aic": 57.266210263276776, + "exp2_cov": 1, + "exp2_rme": 5.5983683837974345, + "exp2_top": 0.000014864682387656134, + "exp3_aic": 59.26620901814293, + "exp3_cov": 1, + "exp3_rme": 5.598367798358593, + "exp3_top": 0.00002325120872148169, + "exp4_aic": 57.266199610517305, + "exp4_cov": 1, + "exp4_rme": 5.598366004275409, + "exp4_top": 5.397987738417918E-10, + "exp5_aic": 59.26619961039384, + "exp5_cov": 1, + "exp5_rme": 5.598366004426082, + "exp5_top": 8.377821726470055E-10, + "gnls_aic": 63.261593119240175, + "gnls_cov": 1, + "gnls_rme": 5.597589879481962, + "gnls_top": 0.20617373336031528, + "hill_aic": 59.26619961110041, + "hill_cov": 1, + "hill_rme": 5.598366004550358, + "hill_top": 8.179987554374146E-10, + "poly1_er": 1.600789285333053, + "poly2_er": 1.600935631744412, + "pow_a_sd": null, + "pow_ac50": 8.764946038692628, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 29.219899561165725, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 46.07206390886932, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 1.8057489415221024, + "exp5_ac50": 1.7684454448433695, + "exp5_p_sd": null, + "gnls_ac50": 0.0011666221360965088, + "gnls_p_sd": 3.279849567472979, + "gnls_q_sd": 92.59655516899352, + "hill_ac50": 0.21326314555729145, + "hill_p_sd": null, + "poly1_aic": 55.26619960963536, + "poly1_cov": 1, + "poly1_rme": 5.598366004146862, + "poly1_top": 8.329288059838414E-10, + "poly2_aic": 57.266202776564455, + "poly2_cov": 1, + "poly2_rme": 5.598366884119417, + "poly2_top": 0.000005906314023332767, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": 0.31071019075343265, + "gnls_ga_sd": 0.7914627160677781, + "gnls_la_sd": 1.8738093020015376, + "gnls_tp_sd": 4.103388080871007, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.15082807920588523, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.681166613865575, + "poly2_b_sd": null, + "poly1_er_sd": 0.4455631080651304, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.30262790841870524 + }, + "mc5Param": { + "a": 1.665857611967683E-11, + "er": 1.600789285333053, + "ac5": 2.5, + "bmd": 557619187687.316, + "bmr": 9.289141683881516, + "mll": -25.63309980481768, + "top": 8.329288059838414E-10, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 119.31078194095286, + "rmse": 5.598366004146862, + "ac1sd": 413357440835.6679, + "caikwt": 0.7310585786790016, + "hitcall": 2.529472360487395E-7, + "top_over_cutoff": 3.688658180359248E-11 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842421, + "spid": "TP0000267H05", + "chid": 26252, + "casn": "101-02-0", + "chnm": "Triphenyl phosphite", + "dtxsid": "DTXSID0026252", + "bmad": 3.7634679299683276, + "respMax": 2.153448557173647, + "respMin": -10.47000653188537, + "maxMean": 2.153448557173647, + "maxMeanConc": -1.6989700043360187, + "maxMed": 2.153448557173647, + "maxMedConc": -1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 20, + "m5id": 5037067, + "modl": "poly1", + "hitc": 1.9363278182448674E-6, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.3010299956639812, + -1.6989700043360187, + 1.6989700043360187, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + -0.22184874961635637 + ], + "resp": [ + -8.233558829804824, + 2.153448557173647, + -5.178906539470438, + -7.2693827013629715, + -2.153448557173647, + -8.802875120938111, + -4.04098335160478, + -10.47000653188537 + ] + }, + "mc4Param": { + "pow_a": 3.4292130710908686E-8, + "pow_p": 0.33928487781574906, + "exp2_a": 0.0000127162267603712, + "exp2_b": 59.471246282597455, + "exp3_a": 0.000005456305245978216, + "exp3_b": 57.114981601771404, + "exp3_p": 4.737468297497621, + "exp5_p": 2.059721964231659, + "gnls_p": 3.7705534652747152, + "gnls_q": 7.98088765765917, + "hill_p": 1.8558453157097723, + "pow_er": 1.8316691732485768, + "cnst_er": 1.8316611738832205, + "exp2_er": 1.83171063967293, + "exp3_er": 1.8308588373067065, + "exp4_er": 1.831667717841896, + "exp4_ga": 2.39650583299111, + "exp4_tp": 9.736616090061843E-11, + "exp5_er": 1.8316409278190295, + "exp5_ga": 0.91710788966815, + "exp5_tp": 4.769155469756227E-10, + "gnls_er": 1.826653351166183, + "gnls_ga": 0.0020000000000068045, + "gnls_la": 0.06324555325220907, + "gnls_tp": 1.3708737937327125, + "hill_er": 1.8316765475841592, + "hill_ga": 0.1570478773337086, + "hill_tp": 4.665489172046982E-10, + "poly1_a": 1.6553661788288878E-11, + "poly2_a": 0.0000040937639725312225, + "poly2_b": 57.77189852066546, + "pow_aic": 60.52616872375968, + "pow_cov": 1, + "pow_rme": 6.709809695768132, + "pow_top": 1.2930916305837965E-7, + "all_bmed": 0, + "cnst_aic": 56.52616859619864, + "cnst_rme": 6.709809645256235, + "exp2_aic": 60.526175980843824, + "exp2_cov": 1, + "exp2_rme": 6.709812374327744, + "exp2_top": 0.000016761097647759444, + "exp3_aic": 62.52617699352762, + "exp3_cov": 1, + "exp3_rme": 6.709810021618865, + "exp3_top": 0.000003836214039161115, + "exp4_aic": 60.52616859672308, + "exp4_cov": 1, + "exp4_rme": 6.709809645302461, + "exp4_top": 9.736616090061843E-11, + "exp5_aic": 62.52616860177177, + "exp5_cov": 1, + "exp5_rme": 6.709809645540375, + "exp5_top": 4.769155469756227E-10, + "gnls_aic": 66.46070980336975, + "gnls_cov": 1, + "gnls_rme": 6.690902645418204, + "gnls_top": 1.3705036887888815, + "hill_aic": 62.52616859958253, + "hill_cov": 1, + "hill_rme": 6.709809645620258, + "hill_top": 4.665489172046982E-10, + "poly1_er": 1.8315037737657676, + "poly2_er": 1.8310229156461169, + "pow_a_sd": null, + "pow_ac50": 6.482186378904536, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 30.106803250288905, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 44.336210554612904, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 2.39650583299111, + "exp5_ac50": 0.91710788966815, + "exp5_p_sd": null, + "gnls_ac50": 0.001999713670738839, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 0.1570478773337086, + "hill_p_sd": null, + "poly1_aic": 58.5261688787493, + "poly1_cov": 1, + "poly1_rme": 6.7098096454111325, + "poly1_top": 8.276830894144437E-10, + "poly2_aic": 60.52617604664733, + "poly2_cov": 1, + "poly2_rme": 6.709810691449007, + "poly2_top": 0.000006609445990107358, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": 0.2972944391380977, + "exp4_ga_sd": 2.7511788983437424, + "exp4_tp_sd": 0.000018170256552519125, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.232877570932672, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.51687497965734, + "poly2_b_sd": null, + "poly1_er_sd": 0.4976104385069312, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.06324979854754481 + }, + "mc5Param": { + "a": 1.6553661788288878E-11, + "er": 1.8315037737657676, + "ac5": 2.5, + "bmd": 561153284553.225, + "bmr": 9.289141683881516, + "mll": -27.26308443937465, + "top": 8.276830894144437E-10, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 97.36337686032884, + "rmse": 6.7098096454111325, + "ac1sd": 415977230951.2416, + "caikwt": 0.7310586064064195, + "hitcall": 0.0000019363278182448674, + "top_over_cutoff": 3.665427316933053E-11 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842422, + "spid": "TP0000267H07", + "chid": 22187, + "casn": "2416-94-6", + "chnm": "2,3,6-Trimethylphenol", + "dtxsid": "DTXSID6022187", + "bmad": 3.7634679299683276, + "respMax": 2.4546434804120567, + "respMin": -6.590039447466564, + "maxMean": 2.4546434804120567, + "maxMeanConc": -1.6989700043360187, + "maxMed": 2.4546434804120567, + "maxMedConc": -1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 21, + "m5id": 5037068, + "modl": "poly1", + "hitc": 1.1548465742145037E-8, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + 1.6989700043360187, + 1.3010299956639813, + -0.6989700043360187, + -1.6989700043360187, + -0.22184874961635637 + ], + "resp": [ + -0.6193413590687559, + -2.946862891147046, + -2.4546434804120567, + -2.0619838822007726, + -6.1122061271300225, + -6.590039447466564, + 2.4546434804120567, + -5.079836079239133 + ] + }, + "mc4Param": { + "pow_a": 3.767364113336769E-8, + "pow_p": 0.3793361095119566, + "exp2_a": 0.000013714158244907544, + "exp2_b": 62.473953885282626, + "exp3_a": 0.000003218586676112593, + "exp3_b": 54.793432376427845, + "exp3_p": 4.934528552083529, + "exp5_p": 2.5321434240687077, + "gnls_p": 1.7215545335763185, + "gnls_q": 5.9509617790505365, + "hill_p": 1.7113570602226835, + "pow_er": 1.3001645899703465, + "cnst_er": 1.3001163668151825, + "exp2_er": 1.2988900114548922, + "exp3_er": 1.299714305686752, + "exp4_er": 1.300111607345526, + "exp4_ga": 2.4635749935922417, + "exp4_tp": 2.141208914552821E-10, + "exp5_er": 1.3001191325357075, + "exp5_ga": 0.8329186071996519, + "exp5_tp": 9.468502830411367E-10, + "gnls_er": 1.300129441131634, + "gnls_ga": 0.02488389878063567, + "gnls_la": 0.8513441076183489, + "gnls_tp": 5.029312168256246E-10, + "hill_er": 1.3001098844504215, + "hill_ga": 1.3104070841784885, + "hill_tp": 2.3984539370057496E-10, + "poly1_a": 6.429960167444698E-12, + "poly2_a": 0.00010731334828336232, + "poly2_b": 52.50758262350933, + "pow_aic": 52.26528261409156, + "pow_cov": 1, + "pow_rme": 4.061439597937862, + "pow_top": 1.661568568423234E-7, + "all_bmed": 0, + "cnst_aic": 48.26528238427001, + "cnst_rme": 4.0614395482423795, + "exp2_aic": 52.265309193522334, + "exp2_cov": 1, + "exp2_rme": 4.061441753257708, + "exp2_top": 0.000016817443713639312, + "exp3_aic": 54.26528524536559, + "exp3_cov": 1, + "exp3_rme": 4.061439734220189, + "exp3_top": 0.0000028641829217196966, + "exp4_aic": 52.26528238577886, + "exp4_cov": 1, + "exp4_rme": 4.06143954832149, + "exp4_top": 2.141208914552821E-10, + "exp5_aic": 54.26528238551149, + "exp5_cov": 1, + "exp5_rme": 4.0614395486267245, + "exp5_top": 9.468502830411367E-10, + "gnls_aic": 58.26528238429869, + "gnls_cov": 1, + "gnls_rme": 4.061439548428354, + "gnls_top": 4.953675513002026E-10, + "hill_aic": 54.26528238638662, + "hill_cov": 1, + "hill_rme": 4.061439548335382, + "hill_top": 2.3984539370057496E-10, + "poly1_er": 1.3004069598601156, + "poly2_er": 1.3007699140477382, + "pow_a_sd": null, + "pow_ac50": 8.042653781004834, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 29.874021672293665, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 44.74689545963496, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 2.4635749935922417, + "exp5_ac50": 0.8329186071996519, + "exp5_p_sd": null, + "gnls_ac50": 0.02445288131245627, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 1.3104070841784885, + "hill_p_sd": 3186952.8147538053, + "poly1_aic": 50.26528324291422, + "poly1_cov": 1, + "poly1_rme": 4.061439548291606, + "poly1_top": 3.2149800837223486E-10, + "poly2_aic": 52.26540339182091, + "poly2_cov": 1, + "poly2_rme": 4.061464432547128, + "poly2_top": 0.00019949668932343944, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.30383111979982436, + "hill_ga_sd": 748711.7747256848, + "hill_tp_sd": 0.0000505315540909725, + "poly1_a_sd": 0.09096805428665258, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.772089863628302, + "poly2_b_sd": null, + "poly1_er_sd": 0.3809692717546628, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.8550161183126147 + }, + "mc5Param": { + "a": 6.429960167444698E-12, + "er": 1.3004069598601156, + "ac5": 2.4999999999999996, + "bmd": 1444665509891.1868, + "bmr": 9.289141683881516, + "mll": -23.13264162145711, + "top": 3.2149800837223486E-10, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 149.5912710282903, + "rmse": 4.061439548291606, + "ac1sd": 1070915870934.9048, + "caikwt": 0.7310586630398459, + "hitcall": 1.1548465742145036E-8, + "top_over_cutoff": 1.4237666533224164E-11 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842423, + "spid": "TP0000268B05", + "chid": 47331, + "casn": "331623-06-4", + "chnm": "MK-547", + "dtxsid": "DTXSID4047331", + "bmad": 3.7634679299683276, + "respMax": 16.160587759184914, + "respMin": -11.834811380876454, + "maxMean": 16.160587759184914, + "maxMeanConc": -0.1549019599857432, + "maxMed": 16.160587759184914, + "maxMedConc": -0.1549019599857432, + "logcMax": 1.7781512503836436, + "logcMin": -1.5228787452803376, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 1, + "tmpi": 22, + "m5id": 5037069, + "modl": "poly1", + "hitc": 5.913901142194764E-5, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 22.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -1.5228787452803376, + 1.7781512503836436, + 0.3010299956639812, + 0.7781512503836436, + -1.0969100130080565, + 1.3010299956639813, + -0.6989700043360187, + -0.1549019599857432 + ], + "resp": [ + 1.0328742333020546, + -0.4101716381589, + -11.834811380876454, + -10.26235792055114, + -1.0328742333020546, + 1.4772968670590867, + -2.9469637282292744, + 16.160587759184914 + ] + }, + "mc4Param": { + "pow_a": 3.435232205446152E-7, + "pow_p": 0.40195886003095355, + "exp2_a": 0.00019185757540890645, + "exp2_b": 78.54636736109194, + "exp3_a": 0.000069246181189659, + "exp3_b": 73.10867338686336, + "exp3_p": 7.6208172674503984, + "exp5_p": 7.998247691004145, + "gnls_p": 7.901592218199406, + "gnls_q": 7.849018931807445, + "hill_p": 7.87734028198097, + "pow_er": 1.8213430667936583, + "cnst_er": 1.8213936756952465, + "exp2_er": 1.823591487999136, + "exp3_er": 1.822387183035188, + "exp4_er": 1.821353215471985, + "exp4_ga": 12.168837805792837, + "exp4_tp": 5.0263714950386055E-8, + "exp5_er": 1.8191975210324889, + "exp5_ga": 14.786689747990971, + "exp5_tp": 0.5317549737304359, + "gnls_er": 1.8213944981829744, + "gnls_ga": 0.1534550745988045, + "gnls_la": 19.550756854420513, + "gnls_tp": 4.787909883851375E-9, + "hill_er": 1.8214163821547027, + "hill_ga": 189.7269026616281, + "hill_tp": 5.920760401696781, + "poly1_a": 2.7530546982407402E-9, + "poly2_a": 0.0002694160974739683, + "poly2_b": 74.60371505672451, + "pow_aic": 62.11585875969622, + "pow_cov": 1, + "pow_rme": 8.060026848987192, + "pow_top": 0.0000017811469363016915, + "all_bmed": 0, + "cnst_aic": 58.115858404353595, + "cnst_rme": 8.06002673396659, + "exp2_aic": 62.11590472013238, + "exp2_cov": 1, + "exp2_rme": 8.060029785010771, + "exp2_top": 0.0002199817611461118, + "exp3_aic": 64.11586654613095, + "exp3_cov": 1, + "exp3_rme": 8.060026843281152, + "exp3_top": 0.000017196997763967384, + "exp4_aic": 62.115858433032486, + "exp4_cov": 1, + "exp4_rme": 8.06002673633787, + "exp4_top": 5.0263714950386055E-8, + "exp5_aic": 64.09764769253101, + "exp5_cov": 1, + "exp5_rme": 8.055656964717214, + "exp5_top": 0.5317549737304359, + "gnls_aic": 68.11585840669358, + "gnls_cov": 1, + "gnls_rme": 8.060026734552624, + "gnls_top": 4.7879098346713356E-9, + "hill_aic": 64.11587669600377, + "hill_cov": 1, + "hill_rme": 8.060031073676338, + "hill_top": 5.920760401696781, + "poly1_er": 1.821434550339795, + "poly2_er": 1.821797531197728, + "pow_a_sd": null, + "pow_ac50": 10.696551181133351, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 35.59499774025152, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 55.17214374903797, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 12.168837805792837, + "exp5_ac50": 14.786689747990971, + "exp5_p_sd": 121.15686871088236, + "gnls_ac50": 0.1534550738830234, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 189.7269026616281, + "hill_p_sd": null, + "poly1_aic": 60.11585841484666, + "poly1_cov": 1, + "poly1_rme": 8.06002673693981, + "poly1_top": 1.651832818944444E-7, + "poly2_aic": 62.115872817500886, + "poly2_cov": 1, + "poly2_rme": 8.06003160725891, + "poly2_top": 0.0003909407381656776, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": 0.3534660798818326, + "exp5_ga_sd": 95.93402528978984, + "exp5_tp_sd": 3.9415248388741375, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.08777291902049782, + "poly1_ac50": 30, + "poly2_a_sd": null, + "poly2_ac50": 36.38355504948771, + "poly2_b_sd": null, + "poly1_er_sd": 0.3531459297080129, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 19.55075690425482 + }, + "mc5Param": { + "a": 2.7530546982407402E-9, + "er": 1.821434550339795, + "ac5": 3, + "bmd": 3374121730.9694114, + "bmr": 9.289141683881516, + "mll": -28.05792920742333, + "top": 1.651832818944444E-7, + "ac10": 6, + "ac20": 12, + "ac50": 30, + "bmdl": 62.30001927366413, + "rmse": 8.06002673693981, + "ac1sd": 2501202172.6978583, + "caikwt": 0.7310585796615361, + "hitcall": 0.00005913901142194764, + "top_over_cutoff": 7.3152070097855445E-9 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842424, + "spid": "TP0000268B09", + "chid": 47376, + "casn": "648917-13-9", + "chnm": "AVE2865", + "dtxsid": "DTXSID5047376", + "bmad": 3.7634679299683276, + "respMax": 5.797527205844785, + "respMin": -6.504798500619806, + "maxMean": 5.797527205844785, + "maxMeanConc": -0.5228787452803376, + "maxMed": 5.797527205844785, + "maxMedConc": -0.5228787452803376, + "logcMax": 1.3010299956639813, + "logcMin": -2.0, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 23, + "m5id": 5037070, + "modl": "poly1", + "hitc": 3.401746069045992E-7, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 10.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -1, + -0.5228787452803376, + -0.045757490560675115, + 0.47712125471966244, + -1.5228787452803376, + 1.3010299956639813, + 0.9030899869919435, + -2 + ], + "resp": [ + -0.45517858919509946, + 5.797527205844785, + -2.9328129243560577, + -6.504798500619806, + 2.0703869723867707, + 4.550643071685755, + 4.546273464789026, + -2.0703869723867707 + ] + }, + "mc4Param": { + "pow_a": 0.14645761569514076, + "pow_p": 1.1773046495484434, + "exp2_a": 270.97367161658156, + "exp2_b": 1116.4642123562155, + "exp3_a": 77.63471895063142, + "exp3_b": 252.08672173141304, + "exp3_p": 1.0981475406737444, + "exp5_p": 7.999999743873548, + "gnls_p": 7.9999999387204035, + "gnls_q": 7.925643774573192, + "hill_p": 7.999999862236661, + "pow_er": 1.1356265219229824, + "cnst_er": 1.3302829497154869, + "exp2_er": 1.132103795624519, + "exp3_er": 1.1430097651086235, + "exp4_er": 1.1201406029443286, + "exp4_ga": 12.576918087774663, + "exp4_tp": 6.957032563345469, + "exp5_er": 1.004007264778901, + "exp5_ga": 6.457229934853941, + "exp5_tp": 4.594738721200484, + "gnls_er": 1.2052015972921115, + "gnls_ga": 0.15589819888208656, + "gnls_la": 1408.8515612814258, + "gnls_tp": 2.45585111669779, + "hill_er": 1.0057274858019496, + "hill_ga": 5.840707041021681, + "hill_tp": 4.711097825805859, + "poly1_a": 0.24532316641680385, + "poly2_a": 217.59829371138036, + "poly2_b": 906.2718506374296, + "pow_aic": 50.20843275953963, + "pow_cov": 1, + "pow_rme": 3.69500181123112, + "pow_top": 4.982193866207102, + "all_bmed": 0, + "cnst_aic": 48.583528700455965, + "cnst_rme": 4.103082128822365, + "exp2_aic": 50.23261652082196, + "exp2_cov": 1, + "exp2_rme": 3.719604002845105, + "exp2_top": 4.897878431815489, + "exp3_aic": 52.21936455943542, + "exp3_cov": 1, + "exp3_rme": 3.703490261604697, + "exp3_top": 4.954803407260803, + "exp4_aic": 50.24261958999962, + "exp4_cov": 1, + "exp4_rme": 3.763007325226026, + "exp4_top": 6.957032563345469, + "exp5_aic": 50.606708255855864, + "exp5_cov": 1, + "exp5_rme": 3.416863170565935, + "exp5_top": 4.594738721200484, + "gnls_aic": 57.65043497612462, + "gnls_cov": 1, + "gnls_rme": 4.156168266214812, + "gnls_top": 2.455851116697789, + "hill_aic": 50.630370136769535, + "hill_cov": 1, + "hill_rme": 3.421658551377129, + "hill_top": 4.711097825805859, + "poly1_er": 1.1314827238691518, + "poly2_er": 1.1323596578117343, + "pow_a_sd": 0.5502364753741223, + "pow_ac50": 11.10032704166267, + "pow_p_sd": 1.2632680919710386, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 9140.874480213712, + "exp2_ac50": 10.04478364010083, + "exp2_b_sd": 37407.68771741646, + "exp3_a_sd": 1098.7341775704554, + "exp3_ac50": 10.788816917549276, + "exp3_b_sd": 3010.335602136789, + "exp3_p_sd": 1.1986941560896456, + "exp4_ac50": 12.576918087774663, + "exp5_ac50": 6.457229934853941, + "exp5_p_sd": 19.477000675370935, + "gnls_ac50": 0.15589819885359768, + "gnls_p_sd": 20.48523584343925, + "gnls_q_sd": 1762638.0146021335, + "hill_ac50": 5.840707041021681, + "hill_p_sd": 12.47501198328628, + "poly1_aic": 48.23172628107896, + "poly1_cov": 1, + "poly1_rme": 3.7202526561507, + "poly1_top": 4.906463328336078, + "poly2_aic": 50.23384580295357, + "poly2_cov": 1, + "poly2_rme": 3.7190286910920456, + "poly2_top": 4.908027255021525, + "pow_er_sd": 0.32075020244933933, + "exp2_er_sd": 0.32108258944317647, + "exp3_er_sd": 0.3216124902903471, + "exp4_er_sd": 0.32786527141411564, + "exp4_ga_sd": 33.74243671026672, + "exp4_tp_sd": 11.6108227506599, + "exp5_er_sd": 0.334854491636641, + "exp5_ga_sd": 5.3898863226067535, + "exp5_tp_sd": 2.1620411463879097, + "gnls_er_sd": 0.3500317149484511, + "gnls_ga_sd": 0.22054662364571845, + "gnls_la_sd": 2265909239.9199414, + "gnls_tp_sd": 2.2937771724887908, + "hill_er_sd": 0.3351225283208879, + "hill_ga_sd": 4.352134509212842, + "hill_tp_sd": 2.1279907242956564, + "poly1_a_sd": 0.13312558050871134, + "poly1_ac50": 10.000000000000002, + "poly2_a_sd": 4836.680590090178, + "poly2_ac50": 10.107947086330844, + "poly2_b_sd": 19734.212048261263, + "poly1_er_sd": 0.32103720561443533, + "poly2_er_sd": 0.32112575048366343, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 1408.8515612792864 + }, + "mc5Param": { + "a": 0.24532316641680385, + "er": 1.1314827238691518, + "ac5": 1.0000000000000002, + "bmd": 37.86491842396683, + "bmr": 9.289141683881516, + "mll": -22.11586314053948, + "top": 4.906463328336078, + "ac10": 2.0000000000000004, + "ac20": 4.000000000000001, + "ac50": 10.000000000000002, + "bmdl": 18.73361680529658, + "bmdu": 1570.6186096996776, + "rmse": 3.7202526561507, + "ac1sd": 28.068879484037673, + "caikwt": 0.45613773535386626, + "hitcall": 3.401746069045992E-7, + "top_over_cutoff": 0.21728467022247083 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842425, + "spid": "TP0000268D09", + "chid": 47371, + "casn": "725228-45-5", + "chnm": "AVE5638", + "dtxsid": "DTXSID0047371", + "bmad": 3.7634679299683276, + "respMax": 9.829527801511304, + "respMin": -2.5563201140688663, + "maxMean": 9.829527801511304, + "maxMeanConc": 1.6989700043360187, + "maxMed": 9.829527801511304, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 24, + "m5id": 5037071, + "modl": "pow", + "hitc": 8.283608352293161E-12, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.6989700043360187, + -0.22184874961635637, + -1.6989700043360187, + 1.6989700043360187, + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813 + ], + "resp": [ + 0.5431239666670336, + 4.285106967299528, + 2.5563201140688663, + 9.829527801511304, + 5.709719432762615, + 2.4081165876987582, + -2.5563201140688663, + 6.207106279335564 + ] + }, + "mc4Param": { + "pow_a": 2.6134169605347974, + "pow_p": 0.3224547315138239, + "exp2_a": 1847.8710307754577, + "exp2_b": 8594.958431701696, + "exp3_a": 5.951942308809372, + "exp3_b": 55.65624351376668, + "exp3_p": 0.3000009915091093, + "exp5_p": 0.408031291772936, + "gnls_p": 0.5036307275286347, + "gnls_q": 6.983373974900997, + "hill_p": 0.5036130799544578, + "pow_er": 0.6271801481986525, + "cnst_er": 1.483673944403286, + "exp2_er": 0.901885423620896, + "exp3_er": 0.617447007576443, + "exp4_er": 0.7472251905007579, + "exp4_ga": 12.860918984697772, + "exp4_tp": 10.29314061205533, + "exp5_er": 0.6664687774625762, + "exp5_ga": 10.227134832516548, + "exp5_tp": 11.795433349193852, + "gnls_er": 0.6844246765693558, + "gnls_ga": 8.727972134778678, + "gnls_la": 476.21374917073217, + "gnls_tp": 11.795433358441182, + "hill_er": 0.6844058554512551, + "hill_ga": 8.729066041588078, + "hill_tp": 11.795433359489715, + "poly1_a": 0.2155653486726829, + "poly2_a": 1619.371664147901, + "poly2_b": 7562.841340094379, + "pow_aic": 41.42019910503057, + "pow_cov": 1, + "pow_rme": 2.0570817824284617, + "pow_top": 9.226768448403208, + "all_bmed": 0, + "cnst_aic": 51.47828396257371, + "cnst_rme": 5.065500679597487, + "exp2_aic": 46.2016811403628, + "exp2_cov": 1, + "exp2_rme": 2.8349639096704293, + "exp2_top": 10.781066320544063, + "exp3_aic": 43.432265040834096, + "exp3_cov": 1, + "exp3_rme": 2.0734102760632704, + "exp3_top": 9.723220686034583, + "exp4_aic": 44.1490672469169, + "exp4_cov": 1, + "exp4_rme": 2.5333364833268393, + "exp4_top": 10.29314061205533, + "exp5_aic": 43.87885037563678, + "exp5_cov": 1, + "exp5_rme": 2.096972769799834, + "exp5_top": 11.795433349193852, + "gnls_aic": 48.13034965100882, + "gnls_cov": 1, + "gnls_rme": 2.1256207071279647, + "gnls_top": 9.848077588604877, + "hill_aic": 44.13034863233809, + "hill_cov": 1, + "hill_rme": 2.1256162744455236, + "hill_top": 11.795433359489715, + "poly1_er": 0.901280786231684, + "poly2_er": 0.9025570210051496, + "pow_a_sd": 1.2648723107958824, + "pow_ac50": 5.826565328027652, + "pow_p_sd": 0.14109048042799285, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 20517.97016403068, + "exp2_ac50": 25.036358472451216, + "exp2_b_sd": 95129.8509706833, + "exp3_a_sd": 13.444564053482148, + "exp3_ac50": 9.976184034850611, + "exp3_b_sd": 266.0736582783042, + "exp3_p_sd": 0.216903370957182, + "exp4_ac50": 12.860918984697772, + "exp5_ac50": 10.227134832516548, + "exp5_p_sd": 0.1950562304619866, + "gnls_ac50": 4.503531056699209, + "gnls_p_sd": 0.30642623552529974, + "gnls_q_sd": 1778.4355834488583, + "hill_ac50": 8.729066041588078, + "hill_p_sd": 0.30636334171671514, + "poly1_aic": 44.19352001430043, + "poly1_cov": 1, + "poly1_rme": 2.8338486403301544, + "poly1_top": 10.778267433634143, + "poly2_aic": 46.2119706927944, + "poly2_cov": 1, + "poly2_rme": 2.8364410811775858, + "poly2_top": 10.776887264522824, + "pow_er_sd": 0.30099084110430235, + "exp2_er_sd": 0.31175385714527687, + "exp3_er_sd": 0.31176613420103494, + "exp4_er_sd": 0.33118431722536384, + "exp4_ga_sd": 11.325306882966284, + "exp4_tp_sd": 3.4851291549920576, + "exp5_er_sd": 0.3015655658242953, + "exp5_ga_sd": 28.51915767292512, + "exp5_tp_sd": 8.264821291402265, + "gnls_er_sd": 0.3022586634075119, + "gnls_ga_sd": 31.4717089520362, + "gnls_la_sd": 273214.77054124634, + "gnls_tp_sd": 9.227295756030236, + "hill_er_sd": 0.3022524501530625, + "hill_ga_sd": 31.46313562630508, + "hill_tp_sd": 9.22366258473231, + "poly1_a_sd": 0.04384146784814762, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 12062.013966135755, + "poly2_ac50": 25.08209723966715, + "poly2_b_sd": 55965.732274987706, + "poly1_er_sd": 0.31174491997287024, + "poly2_er_sd": 0.31177073301646385, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 483.7219493904507 + }, + "mc5Param": { + "a": 2.6134169605347974, + "p": 0.3224547315138239, + "er": 0.6271801481986525, + "ac5": 0.004615323183986625, + "bmd": 51.05567688873282, + "bmr": 9.289141683881516, + "mll": -17.710099552515285, + "top": 9.226768448403208, + "ac10": 0.039605864897673385, + "ac20": 0.339873172854996, + "ac50": 5.826565328027652, + "bmdl": 25.969322888853053, + "bmdu": 126.0034288976538, + "rmse": 2.0570817824284617, + "ac1sd": 20.17667574437803, + "caikwt": 0.006502515494980162, + "hitcall": 8.283608352293161E-12, + "top_over_cutoff": 0.4086110922203279 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842426, + "spid": "TP0000268F11", + "chid": 47351, + "casn": "464930-42-5", + "chnm": "SSR 240612", + "dtxsid": "DTXSID2047351", + "bmad": 3.7634679299683276, + "respMax": 56.74340329908642, + "respMin": 0.9655862698342526, + "maxMean": 56.74340329908642, + "maxMeanConc": 1.6989700043360187, + "maxMed": 56.74340329908642, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 7, + "tmpi": 25, + "m5id": 5037072, + "modl": "hill", + "hitc": 0.9999997974131798, + "fitc": 42, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 19.100000381469727, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.6989700043360189, + -1.6989700043360187, + 1.3010299956639813, + -0.6989700043360187, + -0.22184874961635637, + 0.3010299956639812, + 1.6989700043360187, + -1.154901959985743 + ], + "resp": [ + 44.59335472538687, + 0.9655862698342526, + 51.07450911124849, + 34.60777964222281, + 38.45466945352135, + 43.944478789484535, + 56.74340329908642, + 15.196453629289444 + ] + }, + "mc4Param": { + "pow_a": 22.29063955606957, + "pow_p": 0.3000000044703735, + "exp2_a": 7377.110355751841, + "exp2_b": 5355.437066929028, + "exp3_a": 591.2413263226587, + "exp3_b": 65665.77024490427, + "exp3_p": 0.300000305401534, + "exp5_p": 7.9983423573434145, + "gnls_p": 1.1287983917282394, + "gnls_q": 7.653239171873807, + "hill_p": 1.1288482557103248, + "pow_er": 2.5032045033922516, + "cnst_er": 3.6332397109938266, + "exp2_er": 3.29296967334806, + "exp3_er": 2.5419130229474893, + "exp4_er": 1.4570282322469614, + "exp4_ga": 0.1211168885912654, + "exp4_tp": 46.88558983477806, + "exp5_er": 1.650383818314157, + "exp5_ga": 0.07454030776539969, + "exp5_tp": 44.37027720585292, + "gnls_er": 1.305161491507147, + "gnls_ga": 0.1388302597633832, + "gnls_la": 4500.7988607575635, + "gnls_tp": 49.11672853031013, + "hill_er": 1.305166813111626, + "hill_ga": 0.13882412839547248, + "hill_tp": 49.116358486825376, + "poly1_a": 1.3848525837844712, + "poly2_a": 6214.513214531438, + "poly2_b": 4538.601931470192, + "pow_aic": 71.6277031240271, + "pow_cov": 1, + "pow_rme": 13.523494389939856, + "pow_top": 72.07979423450467, + "all_bmed": 0, + "cnst_aic": 85.17328329049076, + "cnst_rme": 39.77503672995993, + "exp2_aic": 83.88353944963814, + "exp2_cov": 1, + "exp2_rme": 28.82615638820165, + "exp2_top": 69.19748254971222, + "exp3_aic": 74.18541947887306, + "exp3_cov": 1, + "exp3_rme": 13.997699402413598, + "exp3_top": 72.72562462018436, + "exp4_aic": 55.16605989184805, + "exp4_cov": 1, + "exp4_rme": 5.0053816249751115, + "exp4_top": 46.88558983477806, + "exp5_aic": 60.83333339353628, + "exp5_cov": 1, + "exp5_rme": 6.417783643263895, + "exp5_top": 44.37027720585292, + "gnls_aic": 58.349089094862535, + "gnls_cov": 1, + "gnls_rme": 4.10385604566807, + "gnls_top": 49.11409533247871, + "hill_aic": 54.34908909384654, + "hill_cov": 1, + "hill_rme": 4.103866665590556, + "hill_top": 49.116358486825376, + "poly1_er": 3.291931983247854, + "poly2_er": 3.293092482358462, + "pow_a_sd": null, + "pow_ac50": 4.960628458191019, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 76621.24816189415, + "exp2_ac50": 25.058351701479907, + "exp2_b_sd": 55332.40931606274, + "exp3_a_sd": null, + "exp3_ac50": 5.456350237754098, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 0.1211168885912654, + "exp5_ac50": 0.07454030776539969, + "exp5_p_sd": null, + "gnls_ac50": 0.1388170716544355, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 0.13882412839547248, + "hill_p_sd": 1.0072426298983834, + "poly1_aic": 81.87415000051952, + "poly1_cov": 1, + "poly1_rme": 28.80990540590964, + "poly1_top": 69.24262918922355, + "poly2_aic": 83.8960828082405, + "poly2_cov": 1, + "poly2_rme": 28.846900317891546, + "poly2_top": 69.21708675555531, + "pow_er_sd": null, + "exp2_er_sd": 0.2979467220440815, + "exp3_er_sd": null, + "exp4_er_sd": 0.31706674559933146, + "exp4_ga_sd": 0.02771959613022985, + "exp4_tp_sd": 2.7450192626672303, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.30688202903113515, + "hill_ga_sd": 0.11148548451151348, + "hill_tp_sd": 7.894298278477134, + "poly1_a_sd": 0.49529366199526986, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 42973.45685321085, + "poly2_ac50": 25.136203021763425, + "poly2_b_sd": 30971.57960174396, + "poly1_er_sd": 0.2978316290780377, + "poly2_er_sd": 0.29791923025954864, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 4500.85239695864 + }, + "mc5Param": { + "p": 1.1288482557103248, + "er": 1.305166813111626, + "ga": 0.13882412839547248, + "tp": 49.116358486825376, + "ac5": 0.0102251575317605, + "acc": 0.12033066816769825, + "bmd": 0.03823149140805884, + "bmr": 9.289141683881516, + "mll": -23.17454454692327, + "top": 49.116358486825376, + "ac10": 0.01982170312832394, + "ac20": 0.04065602361491505, + "ac50": 0.13882412839547248, + "bmdl": 0.027228374830847675, + "bmdu": 0.05629923061844972, + "rmse": 4.103866665590556, + "ac1sd": 0.027842487636980728, + "caikwt": 2.0258682012827294E-7, + "hitcall": 0.9999997974131798, + "top_over_cutoff": 2.1751373733303265 + }, + "mc6Param": { + "flag": [ + "Average number of replicates per conc is less than 2", + "Less than 50% efficacy" + ], + "mc6MthdId": [ + 13, + 17 + ] + } + }, + { + "aeid": 704, + "m4id": 1842427, + "spid": "TP0000268G07", + "chid": 47342, + "casn": "NOCAS_47342", + "chnm": "SR125047", + "dtxsid": "DTXSID3047342", + "bmad": 3.7634679299683276, + "respMax": 16.068431608615082, + "respMin": -2.4478548285083273, + "maxMean": 16.068431608615082, + "maxMeanConc": 1.6989700043360187, + "maxMed": 16.068431608615082, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 1, + "tmpi": 26, + "m5id": 5037073, + "modl": "hill", + "hitc": 7.513456343366634E-7, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 18.100000381469727, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.6989700043360189, + 1.3010299956639813, + -0.6989700043360187, + -1.6989700043360187, + 1.6989700043360187, + -0.22184874961635637, + 0.3010299956639812, + -1.2218487496163564 + ], + "resp": [ + 2.578651202272505, + 10.929576624760047, + -2.4478548285083273, + -0.9930052374030435, + 16.068431608615082, + -1.1296964636433144, + -2.031470190077792, + 0.9930052374030434 + ] + }, + "mc4Param": { + "pow_a": 0.7495851450301008, + "pow_p": 0.7934306069332071, + "exp2_a": 3745.887701077395, + "exp2_b": 11161.230229848748, + "exp3_a": 211.17258400046512, + "exp3_b": 1321.9558679160486, + "exp3_p": 0.7862869437104818, + "exp5_p": 1.5971709257356228, + "gnls_p": 1.8437972877629345, + "gnls_q": 6.0802381175989755, + "hill_p": 1.8437982520570464, + "pow_er": 0.5569604229333858, + "cnst_er": 1.496227101300069, + "exp2_er": 0.6013530822669483, + "exp3_er": 0.56192578085808, + "exp4_er": 0.3643457082349424, + "exp4_ga": 18.77713492364612, + "exp4_tp": 19.282117896825127, + "exp5_er": 0.1813537664571939, + "exp5_ga": 14.606417150732632, + "exp5_tp": 16.15853839281399, + "gnls_er": 0.16259772400318157, + "gnls_ga": 15.327772022476056, + "gnls_la": 716.9030513711922, + "gnls_tp": 17.82615761827315, + "hill_er": 0.1626080470170854, + "hill_ga": 15.32785499084368, + "hill_tp": 17.826228582259645, + "poly1_a": 0.33630167057563587, + "poly2_a": 5534.470181137269, + "poly2_b": 16509.417806231653, + "pow_aic": 40.586937969960985, + "pow_cov": 1, + "pow_rme": 1.976876645272376, + "pow_top": 16.70458816459739, + "all_bmed": 0, + "cnst_aic": 54.648400025462585, + "cnst_rme": 7.050414694167261, + "exp2_aic": 41.509916177688794, + "exp2_cov": 1, + "exp2_rme": 2.1346868197498607, + "exp2_top": 16.81844459556715, + "exp3_aic": 42.707146864839885, + "exp3_cov": 1, + "exp3_rme": 1.9923148983459509, + "exp3_top": 16.710344322133963, + "exp4_aic": 37.940991423770946, + "exp4_cov": 1, + "exp4_rme": 1.7263552245064822, + "exp4_top": 19.282117896825127, + "exp5_aic": 36.94109523557594, + "exp5_cov": 1, + "exp5_rme": 1.4202088508960418, + "exp5_top": 16.15853839281399, + "gnls_aic": 40.679025093815895, + "gnls_cov": 1, + "gnls_rme": 1.3995253107697865, + "gnls_top": 17.693918959116115, + "hill_aic": 36.67902495033333, + "hill_cov": 1, + "hill_rme": 1.3995249681145707, + "hill_top": 17.826228582259645, + "poly1_er": 0.6001608259061096, + "poly2_er": 0.6007737931510304, + "pow_a_sd": 0.45733970898996046, + "pow_ac50": 20.872138600405815, + "pow_p_sd": 0.15802993812972735, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 34356.31271501256, + "exp2_ac50": 25.02799868224741, + "exp2_b_sd": 102105.6974126556, + "exp3_a_sd": 651.7340339714862, + "exp3_ac50": 21.20970217173776, + "exp3_b_sd": 4590.856553343913, + "exp3_p_sd": 0.189049486322834, + "exp4_ac50": 18.77713492364612, + "exp5_ac50": 14.606417150732632, + "exp5_p_sd": 0.4330441605396518, + "gnls_ac50": 15.204926781653212, + "gnls_p_sd": 0.5081164715543239, + "gnls_q_sd": 4108.363521527936, + "hill_ac50": 15.32785499084368, + "hill_p_sd": 0.5081331258789696, + "poly1_aic": 39.49794234452144, + "poly1_cov": 1, + "poly1_rme": 2.1327398858741935, + "poly1_top": 16.81508352878179, + "poly2_aic": 41.514073524464166, + "poly2_cov": 1, + "poly2_rme": 2.135746785098317, + "poly2_top": 16.812318280864897, + "pow_er_sd": 0.3123867399094015, + "exp2_er_sd": 0.3173507805054053, + "exp3_er_sd": 0.3132824822426714, + "exp4_er_sd": 0.3204206492367301, + "exp4_ga_sd": 7.538812655873604, + "exp4_tp_sd": 3.614102630459925, + "exp5_er_sd": 0.3228010130363589, + "exp5_ga_sd": 2.1623706344386395, + "exp5_tp_sd": 1.213152398522362, + "gnls_er_sd": 0.3235596345274449, + "gnls_ga_sd": 3.611431409511374, + "gnls_la_sd": 1286628.173870158, + "gnls_tp_sd": 2.3538578449416696, + "hill_er_sd": 0.3235605842861329, + "hill_ga_sd": 3.611520231183444, + "hill_tp_sd": 2.353918902922515, + "poly1_a_sd": 0.035107290392205344, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 43848.155451291146, + "poly2_ac50": 25.037742786782083, + "poly2_b_sd": 130401.28963646913, + "poly1_er_sd": 0.31719198749658833, + "poly2_er_sd": 0.3173229343451282, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 718.4597781609216 + }, + "mc5Param": { + "p": 1.8437982520570464, + "er": 0.1626080470170854, + "ga": 15.32785499084368, + "tp": 17.826228582259645, + "ac5": 3.1041182593433, + "bmd": 16.046024255628595, + "bmr": 9.289141683881516, + "mll": -14.339512475166664, + "top": 17.826228582259645, + "ac10": 4.655214191434633, + "ac20": 7.226847933148336, + "ac50": 15.32785499084368, + "bmdl": 12.817356025918471, + "bmdu": 19.68919163424624, + "rmse": 1.3995249681145707, + "ac1sd": 11.924278068437353, + "caikwt": 0.0001252983526033338, + "hitcall": 7.513456343366634E-7, + "top_over_cutoff": 0.7894415874744223 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842428, + "spid": "TP0000268H11", + "chid": 47362, + "casn": "NOCAS_47362", + "chnm": "SSR150106", + "dtxsid": "DTXSID1047362", + "bmad": 3.7634679299683276, + "respMax": 32.275376253360285, + "respMin": -7.867717756019061, + "maxMean": 32.275376253360285, + "maxMeanConc": 1.6989700043360187, + "maxMed": 32.275376253360285, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 1, + "tmpi": 27, + "m5id": 5037074, + "modl": "poly1", + "hitc": 0.9723023592263895, + "fitc": 42, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.7781512503836436, + -1.154901959985743, + -1.6989700043360187, + 1.3010299956639813, + -0.6989700043360187, + -0.22184874961635637, + 0.3010299956639812, + 1.6989700043360187 + ], + "resp": [ + 7.836812981967315, + -1.688479877558232, + 1.688479877558232, + 11.146812393304948, + 2.103486843396195, + -5.189794556835356, + -7.867717756019061, + 32.275376253360285 + ] + }, + "mc4Param": { + "pow_a": 0.4589901690368699, + "pow_p": 1.0864882638245654, + "exp2_a": 101.4651209324748, + "exp2_b": 181.35011628024697, + "exp3_a": 136.47408823959836, + "exp3_b": 227.43583566565215, + "exp3_p": 1.0244060811915972, + "exp5_p": 1.6543740009751935, + "gnls_p": 2.544254271420234, + "gnls_q": 7.832466215756295, + "hill_p": 2.5440165316447105, + "pow_er": 1.1937920093205483, + "cnst_er": 2.1116016336711736, + "exp2_er": 1.189397204329031, + "exp3_er": 1.1900107506641908, + "exp4_er": 1.3892245596869288, + "exp4_ga": 26.05395024269712, + "exp4_tp": 38.7304515040133, + "exp5_er": 1.236530306766801, + "exp5_ga": 28.81134072021623, + "exp5_tp": 38.73045146929248, + "gnls_er": 1.2683740002383097, + "gnls_ga": 27.607015111885687, + "gnls_la": 4998.569320195761, + "gnls_tp": 38.73045147605155, + "hill_er": 1.2684075667282575, + "hill_ga": 27.60654261703223, + "hill_tp": 38.73045149963589, + "poly1_a": 0.6372560400447195, + "poly2_a": 182.2661163816764, + "poly2_b": 326.31707791831155, + "pow_aic": 51.68671768837355, + "pow_cov": 1, + "pow_rme": 4.1789842044248235, + "pow_top": 32.18950912321905, + "all_bmed": 0, + "cnst_aic": 63.90474507028467, + "cnst_rme": 12.87598788572432, + "exp2_aic": 51.68912006250683, + "exp2_cov": 1, + "exp2_rme": 4.201398457618982, + "exp2_top": 32.211670164602985, + "exp3_aic": 53.68628653722567, + "exp3_cov": 1, + "exp3_rme": 4.193697698573126, + "exp3_top": 32.2049157281836, + "exp4_aic": 54.24612188601166, + "exp4_cov": 1, + "exp4_rme": 4.781182771456221, + "exp4_top": 38.7304515040133, + "exp5_aic": 54.07263547430031, + "exp5_cov": 1, + "exp5_rme": 4.191856927998687, + "exp5_top": 38.73045146929248, + "gnls_aic": 58.62822032794858, + "gnls_cov": 1, + "gnls_rme": 4.334693218513672, + "gnls_top": 38.727333168934166, + "hill_aic": 54.62822039910054, + "hill_cov": 1, + "hill_rme": 4.334666275617764, + "hill_top": 38.73045149963589, + "poly1_er": 1.1994211380897748, + "poly2_er": 1.1893608922995844, + "pow_a_sd": 0.2662014726962556, + "pow_ac50": 26.41818935078147, + "pow_p_sd": 0.1521243947331567, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 348.26640117274536, + "exp2_ac50": 26.717755706472612, + "exp2_b_sd": 548.865968812935, + "exp3_a_sd": 807.847513184223, + "exp3_ac50": 26.72713309062012, + "exp3_b_sd": 1098.3202531522547, + "exp3_p_sd": 0.3785039176466354, + "exp4_ac50": 26.05395024269712, + "exp5_ac50": 28.81134072021623, + "exp5_p_sd": 0.8722989388452311, + "gnls_ac50": 27.605267916591213, + "gnls_p_sd": 2.908874800565709, + "gnls_q_sd": 1691693.862361631, + "hill_ac50": 27.60654261703223, + "hill_p_sd": 2.9035455790005753, + "poly1_aic": 49.794702774441554, + "poly1_cov": 1, + "poly1_rme": 4.2304963707100685, + "poly1_top": 31.86280200223597, + "poly2_aic": 51.69217105908964, + "poly2_cov": 1, + "poly2_rme": 4.2015552080075915, + "poly2_top": 32.206999419449126, + "pow_er_sd": 0.3335534848800435, + "exp2_er_sd": 0.3352306055195441, + "exp3_er_sd": 0.33540266751937425, + "exp4_er_sd": 0.34685487937247106, + "exp4_ga_sd": 14.862078891119456, + "exp4_tp_sd": 14.104706577122425, + "exp5_er_sd": 0.33280432150032224, + "exp5_ga_sd": 14.999794914044722, + "exp5_tp_sd": 18.593299749044046, + "gnls_er_sd": 0.3380749134545, + "gnls_ga_sd": 16.756024987415838, + "gnls_la_sd": 9183669699.444252, + "gnls_tp_sd": 22.121841064908335, + "hill_er_sd": 0.33805915168123435, + "hill_ga_sd": 16.727253222611452, + "hill_tp_sd": 22.083475060963128, + "poly1_a_sd": 0.0558929749060581, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 715.013055008413, + "poly2_ac50": 26.65356756528099, + "poly2_b_sd": 1138.546206698338, + "poly1_er_sd": 0.33129334042250025, + "poly2_er_sd": 0.3350705967166628, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 4998.669787345316 + }, + "mc5Param": { + "a": 0.6372560400447195, + "er": 1.1994211380897748, + "ac5": 2.5, + "acc": 35.43443476538152, + "bmd": 14.57678091717993, + "bmr": 9.289141683881516, + "mll": -22.897351387220777, + "top": 31.86280200223597, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 12.611111933962569, + "bmdu": 17.452581906257134, + "rmse": 4.2304963707100685, + "ac1sd": 10.80561965691618, + "caikwt": 0.0008623202468912801, + "hitcall": 0.9723023592263896, + "top_over_cutoff": 1.411056796335542 + }, + "mc6Param": { + "flag": [ + "Only highest conc above baseline, active", + "Average number of replicates per conc is less than 2", + "Less than 50% efficacy" + ], + "mc6MthdId": [ + 6, + 13, + 17 + ] + } + }, + { + "aeid": 704, + "m4id": 1842429, + "spid": "TP0000269H02", + "chid": 22422, + "casn": "101-77-9", + "chnm": "4,4'-Diaminobiphenyl methane", + "dtxsid": "DTXSID6022422", + "bmad": 3.7634679299683276, + "respMax": 6.633232578988787, + "respMin": -9.288579922195433, + "maxMean": 6.633232578988787, + "maxMeanConc": 1.6989700043360187, + "maxMed": 6.633232578988787, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 28, + "m5id": 5037075, + "modl": "poly1", + "hitc": 3.192301725566275E-7, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + -1.6989700043360187, + 1.6989700043360187, + -0.22184874961635637, + 0.3010299956639812 + ], + "resp": [ + -9.288579922195433, + -1.8279384384638953, + -0.14076023490952427, + -4.745260374024319, + 1.8279384384638953, + 6.633232578988787, + -4.73269516708234, + -1.5362461344536993 + ] + }, + "mc4Param": { + "pow_a": 6.640694251968835E-8, + "pow_p": 4.708272706063721, + "exp2_a": 0.0014256880285145326, + "exp2_b": 5.922987531364045, + "exp3_a": 4.8847255820373086, + "exp3_b": 51.06429898378816, + "exp3_p": 7.307167695500869, + "exp5_p": 7.999659316310423, + "gnls_p": 7.997921197479794, + "gnls_q": 7.999530335677372, + "hill_p": 7.987088871124498, + "pow_er": 1.1589254476238335, + "cnst_er": 1.4044782982786244, + "exp2_er": 1.1606772582682774, + "exp3_er": 1.158287286339332, + "exp4_er": 1.3005392690341286, + "exp4_ga": 47.86270321881696, + "exp4_tp": 7.959879066255224, + "exp5_er": 1.1586163655292807, + "exp5_ga": 44.27571832190897, + "exp5_tp": 7.895000592298389, + "gnls_er": 1.1573094818936194, + "gnls_ga": 40.56058652494757, + "gnls_la": 1282.63837357557, + "gnls_tp": 7.842544176863125, + "hill_er": 1.158759147911965, + "hill_ga": 40.89369026010592, + "hill_tp": 7.959875816540536, + "poly1_a": 0.10491644651330384, + "poly2_a": 0.0006507393642465428, + "poly2_b": 0.5070793867700588, + "pow_aic": 51.41328997449672, + "pow_cov": 1, + "pow_rme": 4.1877013763156805, + "pow_top": 6.628688104808383, + "all_bmed": 0, + "cnst_aic": 50.45420871184967, + "cnst_rme": 4.799166261950659, + "exp2_aic": 51.41291348555145, + "exp2_cov": 1, + "exp2_rme": 4.1880775010710165, + "exp2_top": 6.608583802396452, + "exp3_aic": 53.40921189505927, + "exp3_cov": 1, + "exp3_rme": 4.187148881312595, + "exp3_top": 6.628127374590708, + "exp4_aic": 53.10846032712193, + "exp4_cov": 1, + "exp4_rme": 4.550125713330075, + "exp4_top": 7.959879066255224, + "exp5_aic": 53.40936435022408, + "exp5_cov": 1, + "exp5_rme": 4.187167470953343, + "exp5_top": 7.895000592298389, + "gnls_aic": 57.410191575677814, + "gnls_cov": 1, + "gnls_rme": 4.18726579424983, + "gnls_top": 7.842528457243228, + "hill_aic": 53.41002025565312, + "hill_cov": 1, + "hill_rme": 4.187247227286038, + "hill_top": 7.959875816540536, + "poly1_er": 1.2638071352336775, + "poly2_er": 1.1976543273745366, + "pow_a_sd": 0.0000013788954939727336, + "pow_ac50": 43.15524701052844, + "pow_p_sd": 0.1097737662077741, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 0.012170331308111916, + "exp2_ac50": 45.89577526124489, + "exp2_b_sd": 6.001913269342651, + "exp3_a_sd": null, + "exp3_ac50": 46.66683218601111, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 47.86270321881696, + "exp5_ac50": 44.27571832190897, + "exp5_p_sd": 93.77195086112552, + "gnls_ac50": 40.56056619473948, + "gnls_p_sd": 43.59115160559422, + "gnls_q_sd": 2768980.6256247056, + "hill_ac50": 40.89369026010592, + "hill_p_sd": 56.475026137838405, + "poly1_aic": 50.713583537593315, + "poly1_cov": 1, + "poly1_rme": 4.48292241263243, + "poly1_top": 5.245822325665192, + "poly2_aic": 51.658540260325886, + "poly2_cov": 1, + "poly2_rme": 4.236574457386872, + "poly2_top": 6.391126680630588, + "pow_er_sd": 0.3390660571566805, + "exp2_er_sd": 0.33931424884331485, + "exp3_er_sd": null, + "exp4_er_sd": 0.32712745799309023, + "exp4_ga_sd": 85.09550371327019, + "exp4_tp_sd": 12.38636011110518, + "exp5_er_sd": 0.3391901097874664, + "exp5_ga_sd": 365.25436041198617, + "exp5_tp_sd": 196.19908115352908, + "gnls_er_sd": 0.33907426314020656, + "gnls_ga_sd": 78.57769638557588, + "gnls_la_sd": 1447381779.2912436, + "gnls_tp_sd": 22.236006501316705, + "hill_er_sd": 0.33920566149277925, + "hill_ga_sd": 189.84478002949493, + "hill_tp_sd": 57.07566436306677, + "poly1_a_sd": 0.06310343610315335, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 0.017222480464774936, + "poly2_ac50": 35.28153125132216, + "poly2_b_sd": 6.752089022420825, + "poly1_er_sd": 0.32616650584201273, + "poly2_er_sd": 0.3369788768607837, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 1282.6390163455906 + }, + "mc5Param": { + "a": 0.10491644651330384, + "er": 1.2638071352336775, + "ac5": 2.5, + "bmd": 88.53847030268618, + "bmr": 9.289141683881516, + "mll": -23.356791768796658, + "top": 5.245822325665192, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 44.58314427339827, + "rmse": 4.48292241263243, + "ac1sd": 65.63266886781777, + "caikwt": 0.5323764880588537, + "hitcall": 3.192301725566275E-7, + "top_over_cutoff": 0.23231331772011585 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842443, + "spid": "TP0000904H05", + "chid": 45232, + "casn": "51-24-1", + "chnm": "Tiratricol", + "dtxsid": "DTXSID2045232", + "bmad": 3.7634679299683276, + "respMax": 5.412234762165331, + "respMin": -10.497225111686998, + "maxMean": 5.412234762165331, + "maxMeanConc": -0.6989700043360187, + "maxMed": 5.412234762165331, + "maxMedConc": -0.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 42, + "m5id": 5037089, + "modl": "poly1", + "hitc": 1.3111515548405657E-6, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.7781512503836436, + 1.3010299956639813, + -0.6989700043360187, + -1.6989700043360187, + 1.6989700043360187, + -0.22184874961635637, + 0.3010299956639812, + -1.154901959985743 + ], + "resp": [ + -10.497225111686998, + -8.271301702212094, + 5.412234762165331, + -0.5697089223331855, + -5.4107315723966085, + -1.152645914630851, + -9.935332776150975, + 0.5697089223331855 + ] + }, + "mc4Param": { + "pow_a": 5.868021963410569E-8, + "pow_p": 0.31010469927487905, + "exp2_a": 0.00000820221770260021, + "exp2_b": 63.67412912081, + "exp3_a": 0.000015100154689265508, + "exp3_b": 66.7682650559194, + "exp3_p": 4.045012130124175, + "exp5_p": 2.5184566900851344, + "gnls_p": 1.004146220375644, + "gnls_q": 7.988324375445398, + "hill_p": 2.638717782813107, + "pow_er": 1.748991997794754, + "cnst_er": 1.749320687470586, + "exp2_er": 1.7502584913338175, + "exp3_er": 1.7494323994898786, + "exp4_er": 1.7493097643658628, + "exp4_ga": 3.3432891621411227, + "exp4_tp": 3.7125542218244536E-10, + "exp5_er": 1.7493111824172694, + "exp5_ga": 3.185722315810508, + "exp5_tp": 5.594093755272163E-10, + "gnls_er": 1.7165456563641568, + "gnls_ga": 0.015706640010627146, + "gnls_la": 0.4966875709539269, + "gnls_tp": 2.580846160887361, + "hill_er": 1.749345944481645, + "hill_ga": 33.73657111465509, + "hill_tp": 4.159714315410043E-9, + "poly1_a": 2.671599719093895E-11, + "poly2_a": 0.000005233244887677393, + "poly2_b": 60.3011801386689, + "pow_aic": 59.65799055310836, + "pow_cov": 1, + "pow_rme": 6.498682968118529, + "pow_top": 1.9740143842658864E-7, + "all_bmed": 0, + "cnst_aic": 55.65798921703397, + "cnst_rme": 6.498682892070479, + "exp2_aic": 59.65800315845096, + "exp2_cov": 1, + "exp2_rme": 6.4986846045958355, + "exp2_top": 0.000009784846486708034, + "exp3_aic": 61.657991223897305, + "exp3_cov": 1, + "exp3_rme": 6.4986834826679445, + "exp3_top": 0.00000549637162559571, + "exp4_aic": 59.65798921968127, + "exp4_cov": 1, + "exp4_rme": 6.498682892244033, + "exp4_top": 3.7125542218244536E-10, + "exp5_aic": 61.65798921951322, + "exp5_cov": 1, + "exp5_rme": 6.498682892347669, + "exp5_top": 5.594093755272163E-10, + "gnls_aic": 65.24298472190893, + "gnls_cov": 1, + "gnls_rme": 6.371147760432374, + "gnls_top": 2.422030692633518, + "hill_aic": 61.65798922272976, + "hill_cov": 1, + "hill_rme": 6.498682892532436, + "hill_top": 4.159714315410043E-9, + "poly1_er": 1.7493384697041403, + "poly2_er": 1.749869269967504, + "pow_a_sd": null, + "pow_ac50": 5.348516727471637, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 29.786661402010136, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 42.90853049989956, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 3.3432891621411227, + "exp5_ac50": 3.185722315810508, + "exp5_p_sd": null, + "gnls_ac50": 0.013892709273921892, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 33.73657111465509, + "hill_p_sd": null, + "poly1_aic": 57.65798921945516, + "poly1_cov": 1, + "poly1_rme": 6.49868289233687, + "poly1_top": 1.335799859546947E-9, + "poly2_aic": 59.65799619491047, + "poly2_cov": 1, + "poly2_rme": 6.498684235032681, + "poly2_top": 0.000007937241563467504, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.32379470628075435, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.40176401368837, + "poly2_b_sd": null, + "poly1_er_sd": 0.7320994661619505, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.5007494385640836 + }, + "mc5Param": { + "a": 2.671599719093895E-11, + "er": 1.7493384697041403, + "ac5": 2.4999999999999996, + "bmd": 347699605501.9814, + "bmr": 9.289141683881516, + "mll": -26.82899460972758, + "top": 1.335799859546947E-9, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 108.3553281419698, + "rmse": 6.49868289233687, + "ac1sd": 257746186435.86465, + "caikwt": 0.7310585788680222, + "hitcall": 0.0000013111515548405657, + "top_over_cutoff": 5.915642542126427E-11 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842432, + "spid": "TP0000394E04", + "chid": 20501, + "casn": "1095-90-5", + "chnm": "Methadone hydrochloride", + "dtxsid": "DTXSID2020501", + "bmad": 3.7634679299683276, + "respMax": 53.57668637905514, + "respMin": -4.581867196614961, + "maxMean": 53.57668637905514, + "maxMeanConc": 1.6020599913279625, + "maxMed": 53.57668637905514, + "maxMedConc": 1.6020599913279625, + "logcMax": 1.6020599913279625, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 2, + "tmpi": 31, + "m5id": 5037078, + "modl": "hill", + "hitc": 0.9999279506725846, + "fitc": 42, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 14.5, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 1, + -0.3979400086720376, + 1.6020599913279625, + 0, + -1.6989700043360187, + 0.6020599913279624, + -1.3010299956639813, + -1 + ], + "resp": [ + 21.936647794421265, + -1.740228546008569, + 53.57668637905514, + 0.9551787559185203, + 4.581867196614961, + 5.153028957639964, + -4.581867196614961, + -4.44713457988105 + ] + }, + "mc4Param": { + "pow_a": 2.4561136581257776, + "pow_p": 0.8384142205134059, + "exp2_a": 11320.853419470812, + "exp2_b": 8346.744546958991, + "exp3_a": 1237.9308992517135, + "exp3_b": 1768.9351199634818, + "exp3_p": 0.8316744236700095, + "exp5_p": 1.8016780602346592, + "gnls_p": 1.9766627273478856, + "gnls_q": 4.997108159683513, + "hill_p": 1.9766497079181975, + "pow_er": 1.2490116616663218, + "cnst_er": 2.3406712762674364, + "exp2_er": 1.2565016352167926, + "exp3_er": 1.2497067897586192, + "exp4_er": 1.191255314619447, + "exp4_ga": 16.812978981896514, + "exp4_tp": 64.29202364758979, + "exp5_er": 0.8491056586507115, + "exp5_ga": 11.658831182973834, + "exp5_tp": 53.66634267307796, + "gnls_er": 0.8492765164139605, + "gnls_ga": 13.128901045410975, + "gnls_la": 2844.841004379705, + "gnls_tp": 59.500838623136616, + "hill_er": 0.8492543606297048, + "hill_ga": 13.128917895765634, + "hill_tp": 59.50093497422053, + "poly1_a": 1.35953439410823, + "poly2_a": 16188.436536049236, + "poly2_b": 11947.622892743011, + "pow_aic": 51.10023509243637, + "pow_cov": 1, + "pow_rme": 3.696125539873346, + "pow_top": 54.13003887794411, + "all_bmed": 0, + "cnst_aic": 70.10511686201906, + "cnst_rme": 20.748302126586477, + "exp2_aic": 52.14437661600831, + "exp2_cov": 1, + "exp2_rme": 4.1749638213440265, + "exp2_top": 54.38299031459843, + "exp3_aic": 53.16631363814249, + "exp3_cov": 1, + "exp3_rme": 3.712832014242786, + "exp3_top": 54.12213234353056, + "exp4_aic": 50.26961153208619, + "exp4_cov": 1, + "exp4_rme": 3.527127666309079, + "exp4_top": 64.29202364758979, + "exp5_aic": 48.01142321272821, + "exp5_cov": 1, + "exp5_rme": 2.8599881028288165, + "exp5_top": 53.66634267307796, + "gnls_aic": 52.00868220033195, + "gnls_cov": 1, + "gnls_rme": 2.859115773918567, + "gnls_top": 59.447789496359654, + "hill_aic": 48.00868220032641, + "hill_cov": 1, + "hill_rme": 2.8591158241549053, + "hill_top": 59.50093497422053, + "poly1_er": 1.2550642041651328, + "poly2_er": 1.2548228259159553, + "pow_a_sd": 0.5793958854691459, + "pow_ac50": 17.498995862103317, + "pow_p_sd": 0.06471940367191595, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 91463.2886733445, + "exp2_ac50": 20.023961414836553, + "exp2_b_sd": 67271.17368852775, + "exp3_a_sd": null, + "exp3_ac50": 17.605958078074853, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 16.812978981896514, + "exp5_ac50": 11.658831182973834, + "exp5_p_sd": 0.4678540387944143, + "gnls_ac50": 13.11706285853708, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 13.128917895765634, + "hill_p_sd": 0.5437164914820396, + "poly1_aic": 50.12897105076053, + "poly1_cov": 1, + "poly1_rme": 4.169192622228223, + "poly1_top": 54.38137576432922, + "poly2_aic": 52.15043963754287, + "poly2_cov": 1, + "poly2_rme": 4.1773867080169955, + "poly2_top": 54.3794684457665, + "pow_er_sd": 0.2953728072048604, + "exp2_er_sd": 0.32180507236787287, + "exp3_er_sd": null, + "exp4_er_sd": 0.32050596955935456, + "exp4_ga_sd": 4.7195276601323375, + "exp4_tp_sd": 9.472791030891605, + "exp5_er_sd": 0.3379311586462701, + "exp5_ga_sd": 1.1444511740381855, + "exp5_tp_sd": 2.171328717403055, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.33765766287101917, + "hill_ga_sd": 2.6322294581745154, + "hill_tp_sd": 6.46954953419342, + "poly1_a_sd": 0.08016047186257787, + "poly1_ac50": 20.000000000000007, + "poly2_a_sd": 111138.19550808848, + "poly2_ac50": 20.033367656805616, + "poly2_b_sd": 81749.64462524683, + "poly1_er_sd": 0.3215405880389804, + "poly2_er_sd": 0.3217023608890684, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 2845.828862866811 + }, + "mc5Param": { + "p": 1.9766497079181975, + "er": 0.8492543606297048, + "ga": 13.128917895765634, + "tp": 59.50093497422053, + "ac5": 2.9600505790971923, + "acc": 10.2377822240795, + "bmd": 5.590946990603684, + "bmr": 9.289141683881516, + "mll": -20.00434110016321, + "top": 59.50093497422053, + "ac10": 4.31987731652492, + "ac20": 6.510927354274445, + "ac50": 13.128917895765634, + "bmdl": 4.96194145242722, + "bmdu": 6.331117452796167, + "rmse": 2.8591158241549053, + "ac1sd": 4.69288250612793, + "caikwt": 0.000015915242721747014, + "hitcall": 0.9999279506725846, + "top_over_cutoff": 2.6350224527585864 + }, + "mc6Param": { + "flag": [ + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842430, + "spid": "TP0000270A03", + "chid": 40713, + "casn": "1034-01-1", + "chnm": "Octyl gallate", + "dtxsid": "DTXSID4040713", + "bmad": 3.7634679299683276, + "respMax": 4.0110100385645735, + "respMin": -1753.9651348778787, + "maxMean": 4.0110100385645735, + "maxMeanConc": -0.6989700043360187, + "maxMed": 4.0110100385645735, + "maxMedConc": -0.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 29, + "m5id": 5037076, + "modl": "poly1", + "hitc": 0.09452569552120044, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.22184874961635637, + 0.3010299956639812, + -1.6989700043360187, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + 1.6989700043360187 + ], + "resp": [ + -2.8074617052802946, + 1.0764716849676692, + -3.8481164198730133, + -66.04011500681993, + -22.1044677990717, + -650.3289764196767, + 4.0110100385645735, + -1753.9651348778787 + ] + }, + "mc4Param": { + "pow_a": 0.000005430954273073871, + "pow_p": 0.44356001645759247, + "exp2_a": 0.0002868758851047003, + "exp2_b": 52.29564518101915, + "exp3_a": 0.00007065373025385777, + "exp3_b": 53.07437818010606, + "exp3_p": 7.856638077526047, + "exp5_p": 6.364784886246265, + "gnls_p": 1.0994616555400518, + "gnls_q": 6.028016384412763, + "hill_p": 1.4277336875116893, + "pow_er": 5.478367634135051, + "cnst_er": 5.135878672216937, + "exp2_er": 5.477689913583649, + "exp3_er": 5.48013831055958, + "exp4_er": 5.478384004342792, + "exp4_ga": 0.016244348117744, + "exp4_tp": 5.294724775052426E-7, + "exp5_er": 5.478340674314374, + "exp5_ga": 6.3316531519675445, + "exp5_tp": 2.3312427416913565E-7, + "gnls_er": 5.478333661045958, + "gnls_ga": 0.06561651513532632, + "gnls_la": 4.027166880955711, + "gnls_tp": 0.005795299244329243, + "hill_er": 5.478301864378817, + "hill_ga": 65.48576851856772, + "hill_tp": 5.147568284752382E-7, + "poly1_a": 9.803449957825028E-9, + "poly2_a": 0.0003985692201837858, + "poly2_b": 57.57648587989856, + "pow_aic": 128.0195917417057, + "pow_cov": 1, + "pow_rme": 661.8356526940903, + "pow_top": 0.00003079436898408721, + "all_bmed": 0, + "cnst_aic": 124.3587136415083, + "cnst_rme": 661.8356398173057, + "exp2_aic": 128.01959637464324, + "exp2_cov": 1, + "exp2_rme": 661.8358088666978, + "exp2_top": 0.0004594424423992509, + "exp3_aic": 130.0196021965711, + "exp3_cov": 1, + "exp3_rme": 661.8356601754986, + "exp3_top": 0.00006144291346564819, + "exp4_aic": 128.01959135584116, + "exp4_cov": 1, + "exp4_rme": 661.8356400664329, + "exp4_top": 5.294724775052426E-7, + "exp5_aic": 130.01959133366273, + "exp5_cov": 1, + "exp5_rme": 661.8356399242966, + "exp5_top": 2.3312427416913565E-7, + "gnls_aic": 134.0195953824525, + "gnls_cov": 1, + "gnls_rme": 661.8356575450581, + "gnls_top": 0.005607028353241692, + "hill_aic": 130.01959132750963, + "hill_cov": 1, + "hill_rme": 661.8356398963703, + "hill_top": 5.147568284752382E-7, + "poly1_er": 5.47830425526447, + "poly2_er": 5.47782475358971, + "pow_a_sd": null, + "pow_ac50": 10.478569298304585, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 30.761010400258353, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 46.61973121962576, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 0.016244348117744, + "exp5_ac50": 6.3316531519675445, + "exp5_p_sd": 570927.6166739571, + "gnls_ac50": 0.06184991600912808, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 65.48576851856772, + "hill_p_sd": null, + "poly1_aic": 126.0195913302737, + "poly1_cov": 1, + "poly1_rme": 661.8356400045014, + "poly1_top": 4.901724978912513E-7, + "poly2_aic": 128.0195974654655, + "poly2_cov": 1, + "poly2_rme": 661.8358775325804, + "poly2_top": 0.0006466969391063058, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": 0.5650956309919339, + "exp5_ga_sd": 30541.074886739865, + "exp5_tp_sd": 0.010891154955251125, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": null, + "poly1_ac50": 24.999999999999993, + "poly2_a_sd": null, + "poly2_ac50": 30.525963440706303, + "poly2_b_sd": null, + "poly1_er_sd": null, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 4.056814023436538 + }, + "mc5Param": { + "a": 9.803449957825028E-9, + "er": 5.47830425526447, + "ac5": 2.4999999999999996, + "bmd": 947538032.4114374, + "bmr": 9.289141683881516, + "mll": -61.00979566513685, + "top": 4.901724978912513E-7, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999993, + "bmdl": 1.5904077965907737, + "rmse": 661.8356400045014, + "ac1sd": 702400320.542207, + "caikwt": 0.6964477131643466, + "hitcall": 0.09452569552120044, + "top_over_cutoff": 2.1707483054305203E-8 + }, + "mc6Param": { + "flag": [ + "Model directionality questionable", + "Bmd > ac50, indication of high baseline variability", + "Noisy data", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 5, + 9, + 10, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842431, + "spid": "TP0000270G03", + "chid": 24538, + "casn": "1143-38-0", + "chnm": "Anthralin", + "dtxsid": "DTXSID7024538", + "bmad": 3.7634679299683276, + "respMax": 1.07185605243019, + "respMin": -9693.875949218062, + "maxMean": 1.07185605243019, + "maxMeanConc": -1.6989700043360187, + "maxMed": 1.07185605243019, + "maxMedConc": -1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 30, + "m5id": 5037077, + "modl": "poly1", + "hitc": 0.1121664647692, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.22184874961635637, + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + -1.6989700043360187, + 1.6989700043360187, + 1.3010299956639813, + -0.6989700043360187 + ], + "resp": [ + -290.8004336479407, + -1119.7932814002315, + -3511.304770127347, + -14.130840021191842, + 1.07185605243019, + -9693.875949218062, + -5531.363440142849, + -9.227773090281191 + ] + }, + "mc4Param": { + "pow_a": 0.000016295912787337223, + "pow_p": 0.32150472408902353, + "exp2_a": 0.0005108027295935569, + "exp2_b": 117.05732896371232, + "exp3_a": 0.0007637855137420518, + "exp3_b": 66.37880128554707, + "exp3_p": 1.1690184802745147, + "exp5_p": 1.213976459225782, + "gnls_p": 1.465333545857999, + "gnls_q": 5.282627284696863, + "hill_p": 1.2584446172819073, + "pow_er": 7.913005745260049, + "cnst_er": 7.913106054805518, + "exp2_er": 7.91304122261628, + "exp3_er": 7.912357342166467, + "exp4_er": 7.9130904419643535, + "exp4_ga": 1.5991852149246326, + "exp4_tp": 2.547300452544774E-7, + "exp5_er": 7.913138104543472, + "exp5_ga": 1.0314696395590963, + "exp5_tp": 8.788694104592858E-7, + "gnls_er": 7.913096858909503, + "gnls_ga": 0.007141805168919414, + "gnls_la": 0.22621165840625276, + "gnls_tp": 0.7142118359098187, + "hill_er": 7.913164719748869, + "hill_ga": 0.07017612467977288, + "hill_tp": 0.0000014705482139499703, + "poly1_a": 7.358333303060364E-9, + "poly2_a": 0.02215910584118531, + "poly2_b": 158.14203618196245, + "pow_aic": 160.88623145756264, + "pow_cov": 1, + "pow_rme": 4156.850720832816, + "pow_top": 0.00005731991981836795, + "all_bmed": 0, + "cnst_aic": 156.88623127229403, + "cnst_rme": 4156.850693149301, + "exp2_aic": 160.8862316267931, + "exp2_cov": 1, + "exp2_rme": 4156.850791480489, + "exp2_top": 0.00027219093118124426, + "exp3_aic": 162.88623595855358, + "exp3_cov": 1, + "exp3_rme": 4156.850967911036, + "exp3_top": 0.0008022692602122777, + "exp4_aic": 160.88623127463256, + "exp4_cov": 1, + "exp4_rme": 4156.85069329631, + "exp4_top": 2.547300452544774E-7, + "exp5_aic": 162.88623128180765, + "exp5_cov": 1, + "exp5_rme": 4156.850693669871, + "exp5_top": 8.788694104592858E-7, + "gnls_aic": 166.88623633191477, + "gnls_cov": 1, + "gnls_rme": 4156.851147731188, + "gnls_top": 0.691919808292708, + "hill_aic": 162.8862313001522, + "hill_cov": 1, + "hill_rme": 4156.850694038434, + "hill_top": 0.0000014705482139499703, + "poly1_er": 7.913114168722814, + "poly2_er": 7.913479042407319, + "pow_a_sd": null, + "pow_ac50": 5.7896734789017446, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 27.64958084229515, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 31.74103567254259, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 1.5991852149246326, + "exp5_ac50": 1.0314696395590963, + "exp5_p_sd": null, + "gnls_ac50": 0.006843854769952966, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 0.07017612467977288, + "hill_p_sd": null, + "poly1_aic": 158.88623127321256, + "poly1_cov": 1, + "poly1_rme": 4156.850693286225, + "poly1_top": 3.679166651530182E-7, + "poly2_aic": 160.88624315935962, + "poly2_cov": 1, + "poly2_rme": 4156.854008688916, + "poly2_top": 0.009221198742038497, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 124.06407111097684, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 27.96064454439664, + "poly2_b_sd": null, + "poly1_er_sd": 0.5644466155491178, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.22837814263899145 + }, + "mc5Param": { + "a": 7.358333303060364E-9, + "er": 7.913114168722814, + "ac5": 2.5, + "bmd": 1262397516.0269134, + "bmr": 9.289141683881516, + "mll": -77.44311563660628, + "top": 3.679166651530182E-7, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 0.2092540156485721, + "rmse": 4156.850693286225, + "ac1sd": 935802458.1370742, + "caikwt": 0.7310585787203021, + "hitcall": 0.1121664647692, + "top_over_cutoff": 1.629333511889013E-8 + }, + "mc6Param": { + "flag": [ + "Model directionality questionable", + "Bmd > ac50, indication of high baseline variability", + "Noisy data", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 5, + 9, + 10, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842433, + "spid": "TP0000397C04", + "chid": 47303, + "casn": "179465-71-5", + "chnm": "CJ-013790", + "dtxsid": "DTXSID2047303", + "bmad": 3.7634679299683276, + "respMax": 4.713376683939935, + "respMin": -8.665862529755879, + "maxMean": 4.713376683939935, + "maxMeanConc": 1.6989700043360187, + "maxMed": 4.713376683939935, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 32, + "m5id": 5037079, + "modl": "poly1", + "hitc": 1.4657563430328811E-6, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 1.6989700043360187, + 1.3010299956639813, + -0.22184874961635637, + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + -1.6989700043360187, + -0.6989700043360187 + ], + "resp": [ + 4.713376683939935, + -2.842277469047785, + -8.665862529755879, + -6.370529795363219, + -4.8381205032263255, + 0.16783502687974627, + -0.16783502687974627, + -8.177282570884165 + ] + }, + "mc4Param": { + "pow_a": 4.7151852041982344E-8, + "pow_p": 4.707056641849134, + "exp2_a": 0.00013619254967583104, + "exp2_b": 4.786378022525692, + "exp3_a": 5.900683408927318, + "exp3_b": 53.44092756539992, + "exp3_p": 7.988441200666841, + "exp5_p": 7.999984075925836, + "gnls_p": 7.999997843476933, + "gnls_q": 2.098633684006826, + "hill_p": 7.999998966110843, + "pow_er": 1.4971788764551808, + "cnst_er": 1.5930907333079742, + "exp2_er": 1.4281119149809516, + "exp3_er": 1.495216359023091, + "exp4_er": 1.574893735475315, + "exp4_ga": 89.43517285381708, + "exp4_tp": 5.656051760011978, + "exp5_er": 1.4954679802518542, + "exp5_ga": 44.42715506006904, + "exp5_tp": 5.651471625387929, + "gnls_er": 1.4957921628108226, + "gnls_ga": 41.23384355892483, + "gnls_la": 3602.128748083291, + "gnls_tp": 5.656047237666198, + "hill_er": 1.4957815691417695, + "hill_ga": 41.23453451042785, + "hill_tp": 5.656051677235107, + "poly1_a": 0.050926851808962656, + "poly2_a": 0.000012052724389524282, + "poly2_b": 0.08546364297195863, + "pow_aic": 55.84673202895972, + "pow_cov": 1, + "pow_rme": 5.177530614120443, + "pow_top": 4.684322627141668, + "all_bmed": 0, + "cnst_aic": 52.95155071753253, + "cnst_rme": 5.434921591825441, + "exp2_aic": 55.8743139942496, + "exp2_cov": 1, + "exp2_rme": 5.173806472402641, + "exp2_top": 4.687233137067029, + "exp3_aic": 57.826834706209766, + "exp3_cov": 1, + "exp3_rme": 5.173298710256261, + "exp3_top": 4.718858031320078, + "exp4_aic": 56.73903934336423, + "exp4_cov": 1, + "exp4_rme": 5.385431090855095, + "exp4_top": 5.656051760011978, + "exp5_aic": 57.82823857314273, + "exp5_cov": 1, + "exp5_rme": 5.173596106096281, + "exp5_top": 5.651471625387929, + "gnls_aic": 61.83188800877744, + "gnls_cov": 1, + "gnls_rme": 5.17436656145897, + "gnls_top": 5.650466885579585, + "hill_aic": 57.83188406117348, + "hill_cov": 1, + "hill_rme": 5.174365789583489, + "hill_top": 5.656051677235107, + "poly1_er": 1.5665690518106064, + "poly2_er": 1.5387462152993685, + "pow_a_sd": 0.0000014616637059530786, + "pow_ac50": 43.15360567910734, + "pow_p_sd": 0.21842337803021228, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 0.0017043622702050344, + "exp2_ac50": 46.68247463584101, + "exp2_b_sd": 5.752295568125435, + "exp3_a_sd": null, + "exp3_ac50": 46.62733184577904, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 89.43517285381708, + "exp5_ac50": 44.42715506006904, + "exp5_p_sd": 37.67996399295617, + "gnls_ac50": 41.22454200269515, + "gnls_p_sd": 26.8489978675531, + "gnls_q_sd": 365.5344008388901, + "hill_ac50": 41.23453451042785, + "hill_p_sd": 26.882057159993813, + "poly1_aic": 54.65643655278332, + "poly1_cov": 1, + "poly1_rme": 5.369694576790002, + "poly1_top": 2.5463425904481323, + "poly2_aic": 56.11124549509633, + "poly2_cov": 1, + "poly2_rme": 5.235979290613626, + "poly2_top": 4.132416873278887, + "pow_er_sd": 0.3189018135141268, + "exp2_er_sd": 0.3138862113183906, + "exp3_er_sd": null, + "exp4_er_sd": 0.30874656566105163, + "exp4_ga_sd": 367.1517518690402, + "exp4_tp_sd": 24.085287988419147, + "exp5_er_sd": 0.31920776352680286, + "exp5_ga_sd": 128.5331012831714, + "exp5_tp_sd": 50.817238104594026, + "gnls_er_sd": 0.31925198781323405, + "gnls_ga_sd": 84.12979470825537, + "gnls_la_sd": 2666741.0444864347, + "gnls_tp_sd": 19.50597783562384, + "hill_er_sd": 0.31925103598267796, + "hill_ga_sd": 84.43629556899846, + "hill_tp_sd": 19.57120334180694, + "poly1_a_sd": 0.08732727070509533, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 0.00005470985934134532, + "poly2_ac50": 35.34283609938913, + "poly2_b_sd": 0.1930930384385403, + "poly1_er_sd": 0.3092301889812486, + "poly2_er_sd": 0.3174997459048597, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 3605.517232480094 + }, + "mc5Param": { + "a": 0.050926851808962656, + "er": 1.5665690518106064, + "ac5": 2.4999999999999996, + "bmd": 182.4016477344219, + "bmr": 9.289141683881516, + "mll": -25.32821827639166, + "top": 2.5463425904481323, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 48.45564360274376, + "rmse": 5.369694576790002, + "ac1sd": 135.21248905442692, + "caikwt": 0.7010793489765594, + "hitcall": 0.0000014657563430328811, + "top_over_cutoff": 0.11276578933008924 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842434, + "spid": "TP0000397C07", + "chid": 47290, + "casn": "402910-27-4", + "chnm": "UK-416244", + "dtxsid": "DTXSID0047290", + "bmad": 3.7634679299683276, + "respMax": 20.562993899193387, + "respMin": -1.7128786948219439, + "maxMean": 20.562993899193387, + "maxMeanConc": 1.6989700043360187, + "maxMed": 20.562993899193387, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 1, + "tmpi": 33, + "m5id": 5037080, + "modl": "poly1", + "hitc": 0.013162763209107189, + "fitc": 15, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + 1.6989700043360187, + -0.22184874961635637, + -1.6989700043360187, + 0.3010299956639812, + 0.7781512503836436 + ], + "resp": [ + 1.7128786948219457, + 6.79192117713184, + 0.983536383364406, + 20.562993899193387, + 4.434828570684111, + -1.7128786948219439, + 3.81112438722068, + 3.4559450294617946 + ] + }, + "mc4Param": { + "pow_a": 0.6465352316272346, + "pow_p": 0.8777358322696996, + "exp2_a": 89.17261706113294, + "exp2_b": 242.1062343156615, + "exp3_a": 1.1322547120812192, + "exp3_b": 2.3290546411674624, + "exp3_p": 0.3515182576728658, + "exp5_p": 1.5578879657662703, + "gnls_p": 2.6086058918752, + "gnls_q": 6.488574895843359, + "hill_p": 2.608552656586586, + "pow_er": 0.592938019227486, + "cnst_er": 1.6023141970056376, + "exp2_er": 0.5815399491932731, + "exp3_er": 0.4027853746799608, + "exp4_er": 0.7852662330946163, + "exp4_ga": 25.08568386766411, + "exp4_tp": 24.675592673186735, + "exp5_er": 0.725548250986497, + "exp5_ga": 28.642999510263735, + "exp5_tp": 24.67559255717096, + "gnls_er": 0.7768842111175422, + "gnls_ga": 28.03423084450281, + "gnls_la": 1207.440421430461, + "gnls_tp": 24.675592520708317, + "hill_er": 0.7767855542995623, + "hill_ga": 28.03395361240333, + "hill_tp": 24.675592678367664, + "poly1_a": 0.40607178858594234, + "poly2_a": 177.31422405471238, + "poly2_b": 478.93026660415705, + "pow_aic": 41.233991570138386, + "pow_cov": 1, + "pow_rme": 2.079136922898597, + "pow_top": 20.03729289908219, + "all_bmed": 0, + "cnst_aic": 56.08828664046871, + "cnst_rme": 8.077268192520862, + "exp2_aic": 41.31836603558712, + "exp2_cov": 1, + "exp2_rme": 2.124397197473024, + "exp2_top": 20.455613509941355, + "exp3_aic": 40.32224322278512, + "exp3_cov": 1, + "exp3_rme": 1.7472047427116597, + "exp3_top": 20.256515991910604, + "exp4_aic": 43.99983839294445, + "exp4_cov": 1, + "exp4_rme": 2.4212957674199513, + "exp4_top": 24.675592673186735, + "exp5_aic": 45.31966847370493, + "exp5_cov": 1, + "exp5_rme": 2.3636821866975195, + "exp5_top": 24.67559255717096, + "gnls_aic": 50.24980681608249, + "gnls_cov": 1, + "gnls_rme": 2.506821099601261, + "gnls_top": 24.634723410831995, + "hill_aic": 46.24980691570314, + "hill_cov": 1, + "hill_rme": 2.506818523624102, + "hill_top": 24.675592678367664, + "poly1_er": 0.5923846502517791, + "poly2_er": 0.5823674792019434, + "pow_a_sd": 0.6278658064575703, + "pow_ac50": 22.699069305947805, + "pow_p_sd": 0.2549454765062092, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 359.0395021231347, + "exp2_ac50": 26.288468365058172, + "exp2_b_sd": 886.5958914663547, + "exp3_a_sd": null, + "exp3_ac50": 24.811922046316333, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 25.08568386766411, + "exp5_ac50": 28.642999510263735, + "exp5_p_sd": 1.0227938367314742, + "gnls_ac50": 27.998654408803787, + "gnls_p_sd": 5.461532170943338, + "gnls_q_sd": 22759.167333341324, + "hill_ac50": 28.03395361240333, + "hill_p_sd": 5.452818557413982, + "poly1_aic": 39.39114515732258, + "poly1_cov": 1, + "poly1_rme": 2.122723532583719, + "poly1_top": 20.303589429297116, + "poly2_aic": 41.325165646100416, + "poly2_cov": 1, + "poly2_rme": 2.1244698512830005, + "poly2_top": 20.44407341622616, + "pow_er_sd": 0.3108099654396902, + "exp2_er_sd": 0.3178770115917476, + "exp3_er_sd": null, + "exp4_er_sd": 0.33443563742176596, + "exp4_ga_sd": 13.749752885288313, + "exp4_tp_sd": 8.11750344400524, + "exp5_er_sd": 0.32227571811133654, + "exp5_ga_sd": 12.37560260555014, + "exp5_tp_sd": 10.526695614436056, + "gnls_er_sd": 0.3501482582991739, + "gnls_ga_sd": 29.843090634836496, + "gnls_la_sd": 13481202.453940429, + "gnls_tp_sd": 25.420327925189305, + "hill_er_sd": 0.3500296892891899, + "hill_ga_sd": 29.79588241284215, + "hill_tp_sd": 25.3801674852378, + "poly1_a_sd": 0.030791471721265937, + "poly1_ac50": 25, + "poly2_a_sd": 792.2766056136632, + "poly2_ac50": 26.179002210991253, + "poly2_b_sd": 1966.159052634094, + "poly1_er_sd": 0.31366046598015807, + "poly2_er_sd": 0.31747777530209154, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 1208.036729727654 + }, + "mc5Param": { + "a": 0.40607178858594234, + "er": 0.5923846502517791, + "ac5": 2.5, + "bmd": 22.87561447257627, + "bmr": 9.289141683881516, + "mll": -17.69557257866129, + "top": 20.303589429297116, + "ac10": 5, + "ac20": 10, + "ac50": 25, + "bmdl": 20.16263893407659, + "bmdu": 26.70412321005569, + "rmse": 2.122723532583719, + "ac1sd": 16.95746069130932, + "caikwt": 0.00023667860169117045, + "hitcall": 0.013162763209107187, + "top_over_cutoff": 0.8991524929981263 + }, + "mc6Param": { + "flag": [ + "Borderline", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 11, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842435, + "spid": "TP0000880C04", + "chid": 33923, + "casn": "32809-16-8", + "chnm": "Procymidone", + "dtxsid": "DTXSID9033923", + "bmad": 3.7634679299683276, + "respMax": 3.8699568062787453, + "respMin": -24.489107339892946, + "maxMean": 3.8699568062787453, + "maxMeanConc": -1.6989700043360187, + "maxMed": 3.8699568062787453, + "maxMedConc": -1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 34, + "m5id": 5037081, + "modl": "poly1", + "hitc": 2.0097205336309178E-4, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 1.6989700043360187, + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + -0.22184874961635637, + 0.3010299956639812, + -1.6989700043360187, + 0.7781512503836436 + ], + "resp": [ + -16.749193727335452, + -3.8699568062787457, + -24.489107339892946, + -2.381126076423389, + -0.43391299854400067, + -11.816416045813897, + 3.8699568062787453, + -18.88319457236392 + ] + }, + "mc4Param": { + "pow_a": 1.952362597456107E-7, + "pow_p": 0.39552329951433673, + "exp2_a": 0.0000013815285997456324, + "exp2_b": 57.36258080607493, + "exp3_a": 0.0001480645519160266, + "exp3_b": 58.52389350028799, + "exp3_p": 3.781832639454812, + "exp5_p": 2.151688320633654, + "gnls_p": 4.527989650709323, + "gnls_q": 5.108399001356277, + "hill_p": 1.303035732677177, + "pow_er": 2.418785008334611, + "cnst_er": 2.4188909137985077, + "exp2_er": 2.4174176897085324, + "exp3_er": 2.419726742963499, + "exp4_er": 2.4189096181956495, + "exp4_ga": 12.65722171867288, + "exp4_tp": 1.0355875462847547E-9, + "exp5_er": 2.4189155605747237, + "exp5_ga": 2.333940770138562, + "exp5_tp": 7.523689804982252E-10, + "gnls_er": 2.418842358875211, + "gnls_ga": 0.006221346383250256, + "gnls_la": 0.1981088801387234, + "gnls_tp": 1.090792464590304E-7, + "hill_er": 2.4188877929803674, + "hill_ga": 11.485567544481444, + "hill_tp": 2.7451333346567636E-9, + "poly1_a": 2.0842008078263976E-11, + "poly2_a": 0.000005049104462465559, + "poly2_b": 54.21786559908971, + "pow_aic": 70.76387560116336, + "pow_cov": 1, + "pow_rme": 13.286580877800748, + "pow_top": 9.173661286959486E-7, + "all_bmed": 0, + "cnst_aic": 66.76387501055429, + "cnst_rme": 13.28658048320367, + "exp2_aic": 70.7638964289917, + "exp2_cov": 1, + "exp2_rme": 13.28658095149074, + "exp2_top": 0.0000019214971296937626, + "exp3_aic": 72.76390545298773, + "exp3_cov": 1, + "exp3_rme": 13.28659824551256, + "exp3_top": 0.00010892669639514888, + "exp4_aic": 70.7638750136908, + "exp4_cov": 1, + "exp4_rme": 13.286580483579051, + "exp4_top": 1.0355875462847547E-9, + "exp5_aic": 72.76387501605065, + "exp5_cov": 1, + "exp5_rme": 13.2865804836615, + "exp5_top": 7.523689804982252E-10, + "gnls_aic": 76.76387503731891, + "gnls_cov": 1, + "gnls_rme": 13.286580484397929, + "gnls_top": 1.090255384568449E-7, + "hill_aic": 72.76387501190618, + "hill_cov": 1, + "hill_rme": 13.286580484182, + "hill_top": 2.7451333346567636E-9, + "poly1_er": 2.4189004532043645, + "poly2_er": 2.418496776366225, + "pow_a_sd": null, + "pow_ac50": 8.667164755308963, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 30.28360145565822, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 43.05544733482424, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 12.65722171867288, + "exp5_ac50": 2.333940770138562, + "exp5_p_sd": null, + "gnls_ac50": 0.006219991242649403, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 11.485567544481444, + "hill_p_sd": 182115.5261684, + "poly1_aic": 68.7638750114407, + "poly1_cov": 1, + "poly1_rme": 13.286580483490953, + "poly1_top": 1.0421004039131984E-9, + "poly2_aic": 70.76387916054314, + "poly2_cov": 1, + "poly2_rme": 13.286582613515252, + "poly2_top": 0.00000895038468449257, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.32318093486450644, + "hill_ga_sd": 39787.827708636134, + "hill_tp_sd": 0.00014220966225169602, + "poly1_a_sd": null, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.68674937055745, + "poly2_b_sd": null, + "poly1_er_sd": null, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.19814706168674365 + }, + "mc5Param": { + "a": 2.0842008078263976E-11, + "er": 2.4189004532043645, + "ac5": 2.4999999999999996, + "bmd": 445693219626.4291, + "bmr": 9.289141683881516, + "mll": -32.38193750572035, + "top": 1.0421004039131984E-9, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 58.80191266271995, + "rmse": 13.286580483490953, + "ac1sd": 330387857395.42554, + "caikwt": 0.731058578717145, + "hitcall": 0.00020097205336309175, + "top_over_cutoff": 4.614982879730862E-11 + }, + "mc6Param": { + "flag": [ + "Model directionality questionable", + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 5, + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842436, + "spid": "TP0000881A11", + "chid": 48175, + "casn": "151506-44-4", + "chnm": "Difpas-pyrazole", + "dtxsid": "DTXSID6048175", + "bmad": 3.7634679299683276, + "respMax": 9.134362565846857, + "respMin": -9.785612022505717, + "maxMean": 9.134362565846857, + "maxMeanConc": 0.3010299956639812, + "maxMed": 9.134362565846857, + "maxMedConc": 0.3010299956639812, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 35, + "m5id": 5037082, + "modl": "poly1", + "hitc": 1.1947725092996029E-4, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + 1.6989700043360187, + -0.22184874961635637, + -1.6989700043360187 + ], + "resp": [ + 9.134362565846857, + -9.785612022505717, + 3.535593024563581, + 6.742445658286296, + -0.3105023663836639, + 5.823097242106741, + -4.029995470890604, + -3.535593024563581 + ] + }, + "mc4Param": { + "pow_a": 0.5017775225188548, + "pow_p": 0.6591192202685694, + "exp2_a": 453.975198070989, + "exp2_b": 3365.723487674608, + "exp3_a": 47.11060086418455, + "exp3_b": 932.6075153090944, + "exp3_p": 0.6902242901855664, + "exp5_p": 7.999996307955874, + "gnls_p": 7.999999981968314, + "gnls_q": 3.2727881400777346, + "hill_p": 7.999999785978309, + "pow_er": 1.531638797544549, + "cnst_er": 1.7262662747276574, + "exp2_er": 1.5506701363683515, + "exp3_er": 1.536100270032405, + "exp4_er": 1.5089274250976916, + "exp4_ga": 13.628170726573147, + "exp4_tp": 6.977505107544097, + "exp5_er": 1.289488315288251, + "exp5_ga": 1.4438188583318046, + "exp5_tp": 6.178082350961625, + "gnls_er": 1.2953710144587984, + "gnls_ga": 1.10862617843866, + "gnls_la": 4151.891415636962, + "gnls_tp": 6.166337115180187, + "hill_er": 1.4438381777640448, + "hill_ga": 12.482180184563882, + "hill_tp": 6.342080307914102, + "poly1_a": 0.13564844128161777, + "poly2_a": 383.3454143719398, + "poly2_b": 2877.2229593527345, + "pow_aic": 56.75504382566062, + "pow_cov": 1, + "pow_rme": 5.641059195157223, + "pow_top": 6.612032619018348, + "all_bmed": 0, + "cnst_aic": 54.94826792526694, + "cnst_rme": 6.12272333576879, + "exp2_aic": 56.83709901722125, + "exp2_cov": 1, + "exp2_rme": 5.590761673925524, + "exp2_top": 6.794438217682005, + "exp3_aic": 58.76709884295892, + "exp3_cov": 1, + "exp3_rme": 5.627994848984627, + "exp3_top": 6.686017631086944, + "exp4_aic": 56.60430600619944, + "exp4_cov": 1, + "exp4_rme": 5.64803429898856, + "exp4_top": 6.977505107544097, + "exp5_aic": 57.43232581617384, + "exp5_cov": 1, + "exp5_rme": 6.1785465480449275, + "exp5_top": 6.178082350961625, + "gnls_aic": 61.48247646171176, + "gnls_cov": 1, + "gnls_rme": 6.1821614427506155, + "gnls_top": 6.166337058698889, + "hill_aic": 57.56759946363208, + "hill_cov": 1, + "hill_rme": 5.261298696231139, + "hill_top": 6.342080307914102, + "poly1_er": 1.5502075397868125, + "poly2_er": 1.550523396666215, + "pow_a_sd": 1.8425110941903395, + "pow_ac50": 17.468453440300433, + "pow_p_sd": 0.9672892572791348, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 8922.735205678156, + "exp2_ac50": 25.09284693992692, + "exp2_b_sd": 65504.294285102085, + "exp3_a_sd": 613.2900449736795, + "exp3_ac50": 19.20254148908469, + "exp3_b_sd": 11915.632924850908, + "exp3_p_sd": 1.5295163260514226, + "exp4_ac50": 13.628170726573147, + "exp5_ac50": 1.4438188583318046, + "exp5_p_sd": 26.276043660735045, + "gnls_ac50": 1.1086261757300446, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 12.482180184563882, + "hill_p_sd": 15.808942438750206, + "poly1_aic": 54.834448290805426, + "poly1_cov": 1, + "poly1_rme": 5.59051462132586, + "poly1_top": 6.782422064080888, + "poly2_aic": 56.84053243854048, + "poly2_cov": 1, + "poly2_rme": 5.5908588367326715, + "poly2_top": 6.777492495111021, + "pow_er_sd": 0.32653699413281, + "exp2_er_sd": 0.31815485619140227, + "exp3_er_sd": 0.32790889345958, + "exp4_er_sd": 0.33416716724015716, + "exp4_ga_sd": 31.79171894098858, + "exp4_tp_sd": 6.352844098132389, + "exp5_er_sd": 0.3758220092286442, + "exp5_ga_sd": 1.9804842288363265, + "exp5_tp_sd": 2.143982334536147, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.332730110230082, + "hill_ga_sd": 15.134790376842096, + "hill_tp_sd": 2.8528600881389283, + "poly1_a_sd": 0.08178965120744121, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 5071.424671946927, + "poly2_ac50": 25.213497375344687, + "poly2_b_sd": 37395.91769567147, + "poly1_er_sd": 0.31814280871376166, + "poly2_er_sd": 0.3181039857589696, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 4151.891438876929 + }, + "mc5Param": { + "a": 0.13564844128161777, + "er": 1.5502075397868125, + "ac5": 2.5, + "bmd": 68.47953132462807, + "bmr": 9.289141683881516, + "mll": -25.417224145402713, + "top": 6.782422064080888, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 31.540364959678023, + "rmse": 5.59051462132586, + "ac1sd": 50.763181115365505, + "caikwt": 0.48577638435279785, + "hitcall": 0.00011947725092996028, + "top_over_cutoff": 0.3003622452433992 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842437, + "spid": "TP0000900G07", + "chid": 20337, + "casn": "50-41-9", + "chnm": "Clomiphene citrate (1:1)", + "dtxsid": "DTXSID8020337", + "bmad": 3.7634679299683276, + "respMax": 10.898789471139123, + "respMin": -5.515280710520811, + "maxMean": 10.898789471139123, + "maxMeanConc": -0.6989700043360187, + "maxMed": 10.898789471139123, + "maxMedConc": -0.6989700043360187, + "logcMax": 1.6020599913279625, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 36, + "m5id": 5037083, + "modl": "exp5", + "hitc": 9.661810864110531E-17, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 16.799999237060547, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.3010299956639812, + 1.6020599913279625, + 0.6989700043360189, + -1.2218487496163564, + 1, + -0.6989700043360187, + -0.3010299956639812, + -1.6989700043360187 + ], + "resp": [ + 9.542989087509472, + 7.659697931946032, + 2.722279533841609, + 8.963514885797641, + 3.4847031705862404, + 10.898789471139123, + 4.5850191008881405, + -5.515280710520811 + ] + }, + "mc4Param": { + "pow_a": 2.894877828291989, + "pow_p": 0.30000009184154497, + "exp2_a": 507.19665769285456, + "exp2_b": 2390.670092115083, + "exp3_a": 6.049534282925707, + "exp3_b": 57.69378050863092, + "exp3_p": 0.3000001376282075, + "exp5_p": 7.99999942640795, + "gnls_p": 7.999793902840986, + "gnls_q": 0.3000000006452066, + "hill_p": 7.999999962514539, + "pow_er": 1.5751148789361489, + "cnst_er": 1.9204039795995531, + "exp2_er": 1.7462217494828138, + "exp3_er": 1.60658050250781, + "exp4_er": 1.3106985883527575, + "exp4_ga": 0.027758750868336332, + "exp4_tp": 6.630252961291825, + "exp5_er": 1.1618953320857577, + "exp5_ga": 0.04402078526015048, + "exp5_tp": 6.928768027059429, + "gnls_er": 1.078426077644248, + "gnls_ga": 0.044919076585011514, + "gnls_la": 2.255723019139164, + "gnls_tp": 13.078546805362636, + "hill_er": 1.1679042852770425, + "hill_ga": 0.03577555974551571, + "hill_tp": 6.9330269168075835, + "poly1_a": 0.21403725104232135, + "poly2_a": 618.1481332192153, + "poly2_b": 2934.2080821756736, + "pow_aic": 56.78989112699861, + "pow_cov": 1, + "pow_rme": 5.417311928123108, + "pow_top": 8.75484344876054, + "all_bmed": 0, + "cnst_aic": 57.84110962062907, + "cnst_rme": 7.244502292220726, + "exp2_aic": 59.61899839531536, + "exp2_cov": 1, + "exp2_rme": 6.4909481098367, + "exp2_top": 8.557660172303574, + "exp3_aic": 59.43480588967103, + "exp3_cov": 1, + "exp3_rme": 5.672416841872105, + "exp3_top": 8.769641636805533, + "exp4_aic": 52.464863303353795, + "exp4_cov": 1, + "exp4_rme": 4.153583197446473, + "exp4_top": 6.630252961291825, + "exp5_aic": 51.72994045013513, + "exp5_cov": 1, + "exp5_rme": 3.4066258677428043, + "exp5_top": 6.928768027059429, + "gnls_aic": 54.51261883419981, + "gnls_cov": 1, + "gnls_rme": 3.182126811772757, + "gnls_top": 9.472157188065228, + "hill_aic": 51.823001877133166, + "hill_cov": 1, + "hill_rme": 3.426451464532569, + "hill_top": 6.9330269168075835, + "poly1_er": 1.7457558826110058, + "poly2_er": 1.7452968782570826, + "pow_a_sd": null, + "pow_ac50": 3.968505436961949, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 7886.209158743144, + "exp2_ac50": 20.0836575769218, + "exp2_b_sd": 36834.91963316086, + "exp3_a_sd": null, + "exp3_ac50": 7.634424142811094, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 0.027758750868336332, + "exp5_ac50": 0.04402078526015048, + "exp5_p_sd": 16.740985051144577, + "gnls_ac50": 0.04432778118356064, + "gnls_p_sd": 12.005109141069354, + "gnls_q_sd": 0.4874284554370162, + "hill_ac50": 0.03577555974551571, + "hill_p_sd": 8.198400789158134, + "poly1_aic": 57.614782432250024, + "poly1_cov": 1, + "poly1_rme": 6.489573055026577, + "poly1_top": 8.561490041692856, + "poly2_aic": 59.62160290345598, + "poly2_cov": 1, + "poly2_rme": 6.491849855433758, + "poly2_top": 8.541656153189367, + "pow_er_sd": null, + "exp2_er_sd": 0.31177602076055916, + "exp3_er_sd": null, + "exp4_er_sd": 0.30388057834208093, + "exp4_ga_sd": 0.02693013869703401, + "exp4_tp_sd": 1.661867218808188, + "exp5_er_sd": 0.29468062372775733, + "exp5_ga_sd": 0.03680809630884936, + "exp5_tp_sd": 1.4295227932907637, + "gnls_er_sd": 0.3065288310832348, + "gnls_ga_sd": 0.031029309418172207, + "gnls_la_sd": 24.854379539431022, + "gnls_tp_sd": 20.121310783219784, + "hill_er_sd": 0.2958893567650495, + "hill_ga_sd": 0.020109201282715105, + "hill_tp_sd": 1.444345524585305, + "poly1_a_sd": 0.1246611948311575, + "poly1_ac50": 20.000000000000004, + "poly2_a_sd": 7675.09337419141, + "poly2_ac50": 20.1344835005275, + "poly2_b_sd": 35962.194179144324, + "poly1_er_sd": 0.3117610061713438, + "poly2_er_sd": 0.3116647419349434, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 14.889197885456817 + }, + "mc5Param": { + "p": 7.99999942640795, + "er": 1.1618953320857577, + "ga": 0.04402078526015048, + "tp": 6.928768027059429, + "ac5": 0.031791583986919426, + "bmr": 9.289141683881516, + "mll": -21.86497022506757, + "top": 6.928768027059429, + "ac10": 0.03478478563989077, + "ac20": 0.03820565423269564, + "ac50": 0.04402078526015048, + "rmse": 3.4066258677428043, + "ac1sd": 0.056474950476798486, + "caikwt": 0.04497698241958925, + "hitcall": 9.661810864110532E-17, + "top_over_cutoff": 0.30684323413014714 + }, + "mc6Param": { + "flag": [ + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842438, + "spid": "TP0000901C02", + "chid": 44742, + "casn": "929-59-9", + "chnm": "2,2'-[Ethane-1,2-diylbis(oxy)]diethanamine", + "dtxsid": "DTXSID9044742", + "bmad": 3.7634679299683276, + "respMax": 2.102135732023357, + "respMin": -13.866850456669049, + "maxMean": 2.102135732023357, + "maxMeanConc": -1.6989700043360187, + "maxMed": 2.102135732023357, + "maxMedConc": -1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 37, + "m5id": 5037084, + "modl": "poly1", + "hitc": 1.6909241923219796E-5, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -1.6989700043360187, + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + 1.6989700043360187, + 1.3010299956639813, + -0.6989700043360187, + -0.22184874961635637 + ], + "resp": [ + 2.102135732023357, + -9.412448215112468, + -13.866850456669049, + -2.1021357320233576, + -12.917586117741852, + -10.97561525557232, + -6.22147697413914, + -2.080189161400509 + ] + }, + "mc4Param": { + "pow_a": 3.4446382511039494E-8, + "pow_p": 0.405668436564102, + "exp2_a": 0.0000035767163069793493, + "exp2_b": 54.19534891303776, + "exp3_a": 0.00010379978775640668, + "exp3_b": 59.37620949215037, + "exp3_p": 5.888770426636071, + "exp5_p": 1.9821606540096437, + "gnls_p": 0.30001012009352335, + "gnls_q": 7.999995713520498, + "hill_p": 1.7490788379969926, + "pow_er": 2.071207160271089, + "cnst_er": 2.071211568093979, + "exp2_er": 2.087900394504249, + "exp3_er": 2.0726661672288493, + "exp4_er": 2.071198368794665, + "exp4_ga": 1.5550293796779942, + "exp4_tp": 6.854934679554375E-10, + "exp5_er": 2.071188089956425, + "exp5_ga": 1.075853940567168, + "exp5_tp": 7.285098719222379E-11, + "gnls_er": 2.0848424617077885, + "gnls_ga": 0.0036576464311942544, + "gnls_la": 0.11566493705462633, + "gnls_tp": 2.508032612116657, + "hill_er": 2.0712056577390427, + "hill_ga": 0.0943243612038477, + "hill_tp": 1.0236527737537164E-10, + "poly1_a": 2.7800312881203852E-11, + "poly2_a": 0.00000627535807537266, + "poly2_b": 60.95260835116624, + "pow_aic": 64.64743364497741, + "pow_cov": 1, + "pow_rme": 8.804003396114856, + "pow_top": 1.6840777009062426E-7, + "all_bmed": 0, + "cnst_aic": 60.647433518627345, + "cnst_rme": 8.804003324454703, + "exp2_aic": 64.65038867128672, + "exp2_cov": 1, + "exp2_rme": 8.804004670425206, + "exp2_top": 0.0000054215645424565595, + "exp3_aic": 66.64747052230402, + "exp3_cov": 1, + "exp3_rme": 8.804011695015834, + "exp3_top": 0.00004549404939612168, + "exp4_aic": 64.64743351699708, + "exp4_cov": 1, + "exp4_rme": 8.804003324877298, + "exp4_top": 6.854934679554375E-10, + "exp5_aic": 66.6474335170417, + "exp5_cov": 1, + "exp5_rme": 8.804003324503169, + "exp5_top": 7.285098719222379E-11, + "gnls_aic": 70.7685853545882, + "gnls_cov": 1, + "gnls_rme": 8.85030950797314, + "gnls_top": 1.7467856376852715, + "hill_aic": 66.64743351725284, + "hill_cov": 1, + "hill_rme": 8.804003324534168, + "hill_top": 1.0236527737537164E-10, + "poly1_er": 2.071181356064919, + "poly2_er": 2.0591467602950058, + "pow_a_sd": null, + "pow_ac50": 9.055465992561412, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 30.57258064410303, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 45.10566579953819, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 1.5550293796779942, + "exp5_ac50": 1.075853940567168, + "exp5_p_sd": null, + "gnls_ac50": 0.00045274899531010966, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 0.0943243612038477, + "hill_p_sd": null, + "poly1_aic": 62.647433519300336, + "poly1_cov": 1, + "poly1_rme": 8.804003324837579, + "poly1_top": 1.3900156440601922E-9, + "poly2_aic": 64.648984881928, + "poly2_cov": 1, + "poly2_rme": 8.80400563504064, + "poly2_top": 0.000009370471461854893, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": null, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.372856253972696, + "poly2_b_sd": null, + "poly1_er_sd": null, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.11734082051568114 + }, + "mc5Param": { + "a": 2.7800312881203852E-11, + "er": 2.071181356064919, + "ac5": 2.4999999999999996, + "bmd": 334138026560.1983, + "bmr": 9.289141683881516, + "mll": -29.323716759650168, + "top": 1.3900156440601922E-9, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 83.31772378411256, + "rmse": 8.804003324837579, + "ac1sd": 247693125693.253, + "caikwt": 0.7310585786961639, + "hitcall": 0.000016909241923219796, + "top_over_cutoff": 6.155739289426647E-11 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842439, + "spid": "TP0000901G06", + "chid": 37717, + "casn": "1478-61-1", + "chnm": "Bisphenol AF", + "dtxsid": "DTXSID7037717", + "bmad": 3.7634679299683276, + "respMax": 25.02709988877963, + "respMin": -5.116640339141512, + "maxMean": 25.02709988877963, + "maxMeanConc": 1.6989700043360187, + "maxMed": 25.02709988877963, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 2, + "tmpi": 38, + "m5id": 5037085, + "modl": "poly1", + "hitc": 0.4839809180427277, + "fitc": 15, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -1.6989700043360187, + 1.6989700043360187, + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + -0.6989700043360187, + -0.22184874961635637 + ], + "resp": [ + 5.116640339141512, + 25.02709988877963, + -1.5045979142152461, + 18.349042537758507, + -5.116640339141512, + 5.529082512613025, + 0.5975072132046018, + -1.187660181498737 + ] + }, + "mc4Param": { + "pow_a": 0.07159436973182562, + "pow_p": 1.4960735696348564, + "exp2_a": 8.456409712931872, + "exp2_b": 36.37151003282228, + "exp3_a": 4.7469347723334465, + "exp3_b": 24.593641736552343, + "exp3_p": 0.854675613605653, + "exp5_p": 2.264198460682199, + "gnls_p": 3.318653605103369, + "gnls_q": 5.8042879403945875, + "hill_p": 3.319207509571538, + "pow_er": 1.298769240423112, + "cnst_er": 2.069727518985843, + "exp2_er": 1.3076817798550966, + "exp3_er": 1.3140568468982357, + "exp4_er": 1.6046703279553285, + "exp4_ga": 26.25609903911517, + "exp4_tp": 30.03251983398266, + "exp5_er": 1.2910910235308246, + "exp5_ga": 33.09797478746359, + "exp5_tp": 30.032519004305016, + "gnls_er": 1.2904522494318973, + "gnls_ga": 30.9993505952315, + "gnls_la": 1379.821215621746, + "gnls_tp": 30.032519583217184, + "hill_er": 1.2906396868889318, + "hill_ga": 31.00480635661345, + "hill_tp": 30.032519453725904, + "poly1_a": 0.4801784188472726, + "poly2_a": 7.581640517436643, + "poly2_b": 36.27786078315009, + "pow_aic": 56.35279588835657, + "pow_cov": 1, + "pow_rme": 6.682149859256472, + "pow_top": 24.92659682737705, + "all_bmed": 0, + "cnst_aic": 62.96436169588917, + "cnst_rme": 11.456467755742704, + "exp2_aic": 56.21699568284793, + "exp2_cov": 1, + "exp2_rme": 6.540814233283506, + "exp2_top": 24.979385566604833, + "exp3_aic": 58.20667037507905, + "exp3_cov": 1, + "exp3_rme": 6.502564689513747, + "exp3_top": 24.95932460632071, + "exp4_aic": 58.1094254225183, + "exp4_cov": 1, + "exp4_rme": 6.2731787855341095, + "exp4_top": 30.03251983398266, + "exp5_aic": 58.55393829008341, + "exp5_cov": 1, + "exp5_rme": 6.871326153335053, + "exp5_top": 30.032519004305016, + "gnls_aic": 62.67232565633159, + "gnls_cov": 1, + "gnls_rme": 6.968000583173041, + "gnls_top": 30.013400810194607, + "hill_aic": 58.67232739427216, + "hill_cov": 1, + "hill_rme": 6.968054555449975, + "hill_top": 30.032519453725904, + "poly1_er": 1.4547327831413472, + "poly2_er": 1.3132567568023277, + "pow_a_sd": 0.08813493434702901, + "pow_ac50": 31.459849478540292, + "pow_p_sd": 0.3186339393901382, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 16.387643242603666, + "exp2_ac50": 32.98997403636759, + "exp2_b_sd": 38.85953499547879, + "exp3_a_sd": 22.27340883508407, + "exp3_ac50": 33.09824724111999, + "exp3_b_sd": 83.07150496858122, + "exp3_p_sd": 1.0925857934998315, + "exp4_ac50": 26.25609903911517, + "exp5_ac50": 33.09797478746359, + "exp5_p_sd": 2.3249446576593304, + "gnls_ac50": 30.98745994826971, + "gnls_p_sd": 11.859185725142751, + "gnls_q_sd": 30210.660566019513, + "hill_ac50": 31.00480635661345, + "hill_p_sd": 11.897866553982782, + "poly1_aic": 54.92956695032407, + "poly1_cov": 1, + "poly1_rme": 6.304845114135714, + "poly1_top": 24.008920942363627, + "poly2_aic": 56.27311149656675, + "poly2_cov": 1, + "poly2_rme": 6.561527988769902, + "poly2_top": 24.851306266956673, + "pow_er_sd": 0.38981300436821936, + "exp2_er_sd": 0.3898189614605816, + "exp3_er_sd": 0.39290796815857126, + "exp4_er_sd": 0.34668313066113043, + "exp4_ga_sd": 26.90625013028702, + "exp4_tp_sd": 17.283997953709413, + "exp5_er_sd": 0.39740593076852454, + "exp5_ga_sd": 32.129634015331355, + "exp5_tp_sd": 33.76175010764305, + "gnls_er_sd": 0.39760125645615085, + "gnls_ga_sd": 69.85697532885499, + "gnls_la_sd": 23813357.443562742, + "gnls_tp_sd": 66.51521302449146, + "hill_er_sd": 0.3976143434895321, + "hill_ga_sd": 70.09052961350474, + "hill_tp_sd": 66.73515623997775, + "poly1_a_sd": 0.07512526413723014, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 25.10493170570885, + "poly2_ac50": 31.720545290878295, + "poly2_b_sd": 76.80867364470046, + "poly1_er_sd": 0.3462602829941217, + "poly2_er_sd": 0.39170875683118345, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 1380.1223141739165 + }, + "mc5Param": { + "a": 0.4801784188472726, + "er": 1.4547327831413472, + "ac5": 2.5, + "acc": 47.02586933002523, + "bmd": 19.34518778703392, + "bmr": 9.289141683881516, + "mll": -25.464783475162037, + "top": 24.008920942363627, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 15.225799349328566, + "bmdu": 27.980142000769774, + "rmse": 6.304845114135714, + "ac1sd": 14.340391243168211, + "caikwt": 0.017681488290464575, + "hitcall": 0.4839809180427277, + "top_over_cutoff": 1.0632445654348772 + }, + "mc6Param": { + "flag": [ + "Multiple points above baseline, inactive", + "Borderline", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 8, + 11, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842440, + "spid": "TP0000901G12", + "chid": 48511, + "casn": "1062243-51-9", + "chnm": "Ro 3280", + "dtxsid": "DTXSID4048511", + "bmad": 3.7634679299683276, + "respMax": 10.325057625042314, + "respMin": -8.983764245071658, + "maxMean": 10.325057625042314, + "maxMeanConc": -0.22184874961635637, + "maxMed": 10.325057625042314, + "maxMedConc": -0.22184874961635637, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 39, + "m5id": 5037086, + "modl": "poly1", + "hitc": 7.3098271082847474E-6, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 18.600000381469727, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.6989700043360187, + -1.6989700043360187, + -0.22184874961635637, + 0.3010299956639812, + 0.6989700043360189, + -1.2218487496163564, + 1.6989700043360187, + 1.3010299956639813 + ], + "resp": [ + 6.480097196924522, + -0.2515554731701046, + 10.325057625042314, + 1.142930253550185, + -7.730923290188433, + 0.2515554731701055, + 3.1098381663147343, + -8.983764245071658 + ] + }, + "mc4Param": { + "pow_a": 9.6342481700584E-7, + "pow_p": 0.4432645042337321, + "exp2_a": 0.000007399967893446319, + "exp2_b": 3.861528561537906, + "exp3_a": 6.923699292827273, + "exp3_b": 56.58306462368016, + "exp3_p": 7.999746381582563, + "exp5_p": 7.998319899204924, + "gnls_p": 7.999999733938488, + "gnls_q": 7.999994914873606, + "hill_p": 7.999985522691064, + "pow_er": 1.6764333208273414, + "cnst_er": 1.6757159315047794, + "exp2_er": 1.6351776912730394, + "exp3_er": 1.6339748313050555, + "exp4_er": 1.6757250594077964, + "exp4_ga": 6.289265154206966, + "exp4_tp": 1.6850922680145134E-10, + "exp5_er": 1.634304344180973, + "exp5_ga": 0.07106828066816326, + "exp5_tp": 1.535161759146987, + "gnls_er": 1.3295228996669055, + "gnls_ga": 0.063224292527447, + "gnls_la": 1.999327678425197, + "gnls_tp": 7.298128558374947, + "hill_er": 1.6340694275967216, + "hill_ga": 57.330818894657035, + "hill_tp": 12.377335603468827, + "poly1_a": 0.009461767869048447, + "poly2_a": 0.000028686825557986437, + "poly2_b": 0.1807498952770959, + "pow_aic": 58.61519395624266, + "pow_cov": 1, + "pow_rme": 6.125537217447439, + "pow_top": 0.000005456459372025317, + "all_bmed": 0, + "cnst_aic": 54.6151883619927, + "cnst_rme": 6.125536842485228, + "exp2_aic": 58.19296056082926, + "exp2_cov": 1, + "exp2_rme": 6.026299220676452, + "exp2_top": 3.1086952065074684, + "exp3_aic": 60.19312750281706, + "exp3_cov": 1, + "exp3_rme": 6.026368174940302, + "exp3_top": 3.1178027036730622, + "exp4_aic": 58.61518836239423, + "exp4_cov": 1, + "exp4_rme": 6.125536842509785, + "exp4_top": 1.6850922680145134E-10, + "exp5_aic": 60.35216613544548, + "exp5_cov": 1, + "exp5_rme": 6.133102241580869, + "exp5_top": 1.535161759146987, + "gnls_aic": 59.638816472495165, + "gnls_cov": 1, + "gnls_rme": 4.6551870260688855, + "gnls_top": 7.298113962072281, + "hill_aic": 60.193622806346006, + "hill_cov": 1, + "hill_rme": 6.026559284171812, + "hill_top": 12.377335603468827, + "poly1_er": 1.671396299010503, + "poly2_er": 1.647533881452146, + "pow_a_sd": null, + "pow_ac50": 10.467658378845464, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 0.000019653592135234332, + "exp2_ac50": 47.323401556905104, + "exp2_b_sd": 0.7800950706885615, + "exp3_a_sd": null, + "exp3_ac50": 46.359485549724944, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 6.289265154206966, + "exp5_ac50": 0.07106828066816326, + "exp5_p_sd": 1263.5073660910928, + "gnls_ac50": 0.06322426071869278, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 57.330818894657035, + "hill_p_sd": null, + "poly1_aic": 56.6071465334128, + "poly1_cov": 1, + "poly1_rme": 6.1384421956539885, + "poly1_top": 0.4730883934524223, + "poly2_aic": 58.411074893876496, + "poly2_cov": 1, + "poly2_rme": 6.104875979378861, + "poly2_top": 2.2030965746019064, + "pow_er_sd": null, + "exp2_er_sd": 0.3255205050681696, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": 0.3352032946991091, + "exp5_ga_sd": 1.911154416144701, + "exp5_tp_sd": 2.910113134475448, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.10408741267075336, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 0.0008879455965969786, + "poly2_ac50": 35.32892649963858, + "poly2_b_sd": 2.826738198600287, + "poly1_er_sd": 0.32131033280129584, + "poly2_er_sd": 0.3251646386415122, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 1.9993286780943216 + }, + "mc5Param": { + "a": 0.009461767869048447, + "er": 1.671396299010503, + "ac5": 2.5, + "bmd": 981.755398403756, + "bmr": 9.289141683881516, + "mll": -26.3035732667064, + "top": 0.4730883934524223, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 53.80832634227983, + "rmse": 6.1384421956539885, + "ac1sd": 727.7653064520059, + "caikwt": 0.7302672847993994, + "hitcall": 0.0000073098271082847474, + "top_over_cutoff": 0.020950906728217367 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842441, + "spid": "TP0000902A09", + "chid": 48167, + "casn": "138472-01-2", + "chnm": "FR 409", + "dtxsid": "DTXSID2048167", + "bmad": 3.7634679299683276, + "respMax": 8.45824139096988, + "respMin": -4.715592708196917, + "maxMean": 8.45824139096988, + "maxMeanConc": 0.7781512503836436, + "maxMed": 8.45824139096988, + "maxMedConc": 0.7781512503836436, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 40, + "m5id": 5037087, + "modl": "poly1", + "hitc": 4.349091266397037E-7, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.6989700043360187, + -0.22184874961635637, + -1.6989700043360187, + 1.6989700043360187, + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813 + ], + "resp": [ + -1.2342590439036523, + 5.370932466583148, + 0.8322209040287843, + 5.089877121352194, + -4.715592708196917, + 8.45824139096988, + -0.8322209040287843, + 1.8604769341122718 + ] + }, + "mc4Param": { + "pow_a": 1.0221806706745422, + "pow_p": 0.39639742374359954, + "exp2_a": 281.84163059484536, + "exp2_b": 2710.1819410276626, + "exp3_a": 3.070336657854594, + "exp3_b": 58.38202827572274, + "exp3_p": 0.3178065838682131, + "exp5_p": 7.999999556088412, + "gnls_p": 7.997950401679715, + "gnls_q": 0.5167742299566985, + "hill_p": 7.999999636255, + "pow_er": 1.0920563687798213, + "cnst_er": 1.3248432907908116, + "exp2_er": 1.070134684601057, + "exp3_er": 1.0900745687259326, + "exp4_er": 1.0812481377946803, + "exp4_ga": 1.7811347250586496, + "exp4_tp": 4.400696875885273, + "exp5_er": 0.9781436965607416, + "exp5_ga": 4.374536235061529, + "exp5_tp": 5.114592012835368, + "gnls_er": 0.9363241065953332, + "gnls_ga": 3.483652859252365, + "gnls_la": 110.16277693301092, + "gnls_tp": 7.783031273259884, + "hill_er": 0.8800553465055232, + "hill_ga": 0.3510818534236002, + "hill_tp": 4.414701379307003, + "poly1_a": 0.10489123022206318, + "poly2_a": 173.98996532557754, + "poly2_b": 1734.46106467781, + "pow_aic": 49.80239750036858, + "pow_cov": 1, + "pow_rme": 3.6268956792336415, + "pow_top": 4.819422456676002, + "all_bmed": 0, + "cnst_aic": 49.12848756125315, + "cnst_rme": 4.40031788290068, + "exp2_aic": 50.12082719543147, + "exp2_cov": 1, + "exp2_rme": 3.8215443365906254, + "exp2_top": 5.247941640101082, + "exp3_aic": 51.822662540403314, + "exp3_cov": 1, + "exp3_rme": 3.640408829394019, + "exp3_top": 4.884063849755363, + "exp4_aic": 49.4849553439781, + "exp4_cov": 1, + "exp4_rme": 3.556633163595015, + "exp4_top": 4.400696875885273, + "exp5_aic": 49.523866255353845, + "exp5_cov": 1, + "exp5_rme": 3.0787945193813617, + "exp5_top": 5.114592012835368, + "gnls_aic": 53.04563717615321, + "gnls_cov": 1, + "gnls_rme": 3.0191908372849388, + "gnls_top": 6.2867229683220325, + "hill_aic": 50.23685799735487, + "hill_cov": 1, + "hill_rme": 3.720806929349788, + "hill_top": 4.414701379307003, + "poly1_er": 1.0697380575582094, + "poly2_er": 1.068876338903681, + "pow_a_sd": 1.94288100342848, + "pow_ac50": 8.700724003011597, + "pow_p_sd": 0.5142804521178921, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 5978.121364138775, + "exp2_ac50": 25.115304276643503, + "exp2_b_sd": 56967.1422829092, + "exp3_a_sd": 34.884204794475934, + "exp3_ac50": 10.816909274054677, + "exp3_b_sd": 1339.2381888478171, + "exp3_p_sd": 0.7494980203805416, + "exp4_ac50": 1.7811347250586496, + "exp5_ac50": 4.374536235061529, + "exp5_p_sd": 17.23262161929217, + "gnls_ac50": 3.4336886835483624, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 0.3510818534236002, + "hill_p_sd": 11.55230396465234, + "poly1_aic": 48.11858673318644, + "poly1_cov": 1, + "poly1_rme": 3.820595413798474, + "poly1_top": 5.244561511103158, + "poly2_aic": 50.12696585786312, + "poly2_cov": 1, + "poly2_rme": 3.825332733168213, + "poly2_top": 5.160266984567867, + "pow_er_sd": 0.3358088728357998, + "exp2_er_sd": 0.35301842299911645, + "exp3_er_sd": 0.3388919198692416, + "exp4_er_sd": 0.32586774663917945, + "exp4_ga_sd": 2.5289267272649596, + "exp4_tp_sd": 2.0456398887627545, + "exp5_er_sd": 0.3174460886892625, + "exp5_ga_sd": 3.746745018855691, + "exp5_tp_sd": 1.8569699379647628, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.3730906919696318, + "hill_ga_sd": 0.2783296229902509, + "hill_tp_sd": 1.4930457823064731, + "poly1_a_sd": 0.04854843979303387, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 2374.099369826869, + "poly2_ac50": 25.35017708616761, + "poly2_b_sd": 23458.53218916691, + "poly1_er_sd": 0.3529581302897474, + "poly2_er_sd": 0.3530822082323522, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 234.01464386723652 + }, + "mc5Param": { + "a": 0.10489123022206318, + "er": 1.0697380575582094, + "ac5": 2.5, + "bmd": 88.55975532192402, + "bmr": 9.289141683881516, + "mll": -22.05929336659322, + "top": 5.244561511103158, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 47.61937513459634, + "bmdu": 515.5480279689932, + "rmse": 3.820595413798474, + "ac1sd": 65.64844723641512, + "caikwt": 0.37637801032969415, + "hitcall": 4.349091266397037E-7, + "top_over_cutoff": 0.23225748204827024 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842442, + "spid": "TP0000904A04", + "chid": 20932, + "casn": "59-67-6", + "chnm": "Nicotinic acid", + "dtxsid": "DTXSID1020932", + "bmad": 3.7634679299683276, + "respMax": 7.808154220734798, + "respMin": -15.587583552949539, + "maxMean": 7.808154220734798, + "maxMeanConc": -0.6989700043360187, + "maxMed": 7.808154220734798, + "maxMedConc": -0.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 41, + "m5id": 5037088, + "modl": "poly1", + "hitc": 1.2842082484215337E-5, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.7781512503836436, + -1.6989700043360187, + 1.3010299956639813, + -0.6989700043360187, + -0.22184874961635637, + 0.3010299956639812, + 1.6989700043360187, + -1.154901959985743 + ], + "resp": [ + -6.4591483450512746, + 3.0224966031679426, + -15.587583552949539, + 7.808154220734798, + -0.12052294495462057, + -3.3880170099974922, + -12.541681485061535, + -3.0224966031679426 + ] + }, + "mc4Param": { + "pow_a": 5.543622267971873E-7, + "pow_p": 0.364373857362965, + "exp2_a": 5.894362630259528E-7, + "exp2_b": 68.55078029862463, + "exp3_a": 0.0000037615601832033385, + "exp3_b": 69.7561028814606, + "exp3_p": 4.517972377107961, + "exp5_p": 3.4371838689355867, + "gnls_p": 0.30000354623098807, + "gnls_q": 7.948653448964739, + "hill_p": 4.575319604381713, + "pow_er": 1.92339375580289, + "cnst_er": 1.9230667378989736, + "exp2_er": 1.9230442720434788, + "exp3_er": 1.9235351607245372, + "exp4_er": 1.923073891482418, + "exp4_ga": 5.720368939603105, + "exp4_tp": 1.5289441124987554E-10, + "exp5_er": 1.9230858205598875, + "exp5_ga": 3.7080047981398536, + "exp5_tp": 1.358730549491495E-9, + "gnls_er": 1.9069579723705967, + "gnls_ga": 0.03296521485727647, + "gnls_la": 1.0424516568136877, + "gnls_tp": 3.0470136554132834, + "hill_er": 1.923067740437899, + "hill_ga": 144.92218389271736, + "hill_tp": 0.000003918510318302473, + "poly1_a": 2.3821419834720777E-10, + "poly2_a": 0.0000380194771302548, + "poly2_b": 112.44605954378144, + "pow_aic": 62.85990744190046, + "pow_cov": 1, + "pow_rme": 8.160259534186697, + "pow_top": 0.000002305971230116009, + "all_bmed": 0, + "cnst_aic": 58.859904654421854, + "cnst_rme": 8.16025858692367, + "exp2_aic": 62.859904981765446, + "exp2_cov": 1, + "exp2_rme": 8.160258762264611, + "exp2_top": 6.329410925446836E-7, + "exp3_aic": 64.8599070905033, + "exp3_cov": 1, + "exp3_rme": 8.16025876987888, + "exp3_top": 9.357200976922738E-7, + "exp4_aic": 62.85990465443332, + "exp4_cov": 1, + "exp4_rme": 8.160258586995395, + "exp4_top": 1.5289441124987554E-10, + "exp5_aic": 64.85990465768748, + "exp5_cov": 1, + "exp5_rme": 8.160258587645599, + "exp5_top": 1.358730549491495E-9, + "gnls_aic": 68.58354633450392, + "gnls_cov": 1, + "gnls_rme": 8.047045534239281, + "gnls_top": 2.1214791438989553, + "hill_aic": 64.85990466538351, + "hill_cov": 1, + "hill_rme": 8.160258592771067, + "hill_top": 0.000003918510318302473, + "poly1_er": 1.923120606473471, + "poly2_er": 1.923450892386962, + "pow_a_sd": null, + "pow_ac50": 7.461275077538203, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 29.46105839655378, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 43.40360563362071, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 5.720368939603105, + "exp5_ac50": 3.7080047981398536, + "exp5_p_sd": null, + "gnls_ac50": 0.0040734772355949045, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 144.92218389271736, + "hill_p_sd": null, + "poly1_aic": 60.85990468448603, + "poly1_cov": 1, + "poly1_rme": 8.16025859051074, + "poly1_top": 1.1910709917360389E-8, + "poly2_aic": 62.859918528385, + "poly2_cov": 1, + "poly2_rme": 8.160265420971498, + "poly2_top": 0.00002442287818225344, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": null, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 28.760383699947685, + "poly2_b_sd": null, + "poly1_er_sd": null, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 1.0577383522061834 + }, + "mc5Param": { + "a": 2.3821419834720777E-10, + "er": 1.923120606473471, + "ac5": 2.5, + "bmd": 38994911925.2001, + "bmr": 9.289141683881516, + "mll": -28.429952342243016, + "top": 1.1910709917360389E-8, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 93.8246790996463, + "rmse": 8.16025859051074, + "ac1sd": 28906532190.659824, + "caikwt": 0.731058581585493, + "hitcall": 0.000012842082484215337, + "top_over_cutoff": 5.27470502339785E-10 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842403, + "spid": "LEGTV001B10", + "chid": 23900, + "casn": "17804-35-2", + "chnm": "Benomyl", + "dtxsid": "DTXSID5023900", + "bmad": 3.7634679299683276, + "respMax": 25.59444974532059, + "respMin": -1.2102612303412605, + "maxMean": 25.59444974532059, + "maxMeanConc": 0.7781512503836436, + "maxMed": 25.59444974532059, + "maxMedConc": 0.7781512503836436, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 4, + "tmpi": 2, + "m5id": 5037049, + "modl": "exp4", + "hitc": 8.838707536646198E-5, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.22184874961635637, + -1.6989700043360187, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + 0.3010299956639812, + -0.6989700043360187, + 1.6989700043360187 + ], + "resp": [ + 2.9023483672510224, + -1.2102612303412605, + 25.59444974532059, + 1.2102612303412605, + 13.08335350830972, + 13.91717341460287, + 3.6279354590637736, + 13.918360177919546 + ] + }, + "mc4Param": { + "pow_a": 5.205810100365427, + "pow_p": 0.300000106525784, + "exp2_a": 2468.049539504221, + "exp2_b": 7225.095324245473, + "exp3_a": 81.926086402836, + "exp3_b": 11971.021959945418, + "exp3_p": 0.30000050892105745, + "exp5_p": 1.932308954909185, + "gnls_p": 2.2122108268358556, + "gnls_q": 0.8596878616497325, + "hill_p": 3.867980719774923, + "pow_er": 1.3575665310341234, + "cnst_er": 2.320091490701855, + "exp2_er": 1.904101077761098, + "exp3_er": 1.5530301363053958, + "exp4_er": 0.829982332161024, + "exp4_ga": 0.7837526624913668, + "exp4_tp": 14.691482524381094, + "exp5_er": 0.6597965319495738, + "exp5_ga": 0.9532308456224, + "exp5_tp": 14.297652679638324, + "gnls_er": 0.7867729444839626, + "gnls_ga": 1.7121229667458349, + "gnls_la": 54.1420821270971, + "gnls_tp": 26.63271573330083, + "hill_er": 0.6818282209423071, + "hill_ga": 0.8455244118283385, + "hill_tp": 14.238251015246254, + "poly1_a": 0.3429912490465289, + "poly2_a": 2011.137320298468, + "poly2_b": 6041.169272414498, + "pow_aic": 56.93013758751977, + "pow_cov": 1, + "pow_rme": 6.662842960817711, + "pow_top": 16.833696930224765, + "all_bmed": 0, + "cnst_aic": 65.41421720746133, + "cnst_rme": 12.44072681214264, + "exp2_aic": 64.45225922740426, + "exp2_cov": 1, + "exp2_rme": 10.010167810133272, + "exp2_top": 17.13893736437594, + "exp3_aic": 59.42851423204404, + "exp3_cov": 1, + "exp3_rme": 6.738763578058861, + "exp3_top": 17.471290115830215, + "exp4_aic": 48.68746759593549, + "exp4_cov": 1, + "exp4_rme": 4.18881846478536, + "exp4_top": 14.691482524381094, + "exp5_aic": 49.657707875948965, + "exp5_cov": 1, + "exp5_rme": 4.220695557928282, + "exp5_top": 14.297652679638324, + "gnls_aic": 51.15685979133812, + "gnls_cov": 1, + "gnls_rme": 2.7507444039260966, + "gnls_top": 21.79102332025044, + "hill_aic": 50.061396997873935, + "hill_cov": 1, + "hill_rme": 4.276429269729576, + "hill_top": 14.238251015246254, + "poly1_er": 1.9034889654893083, + "poly2_er": 1.9018795046605577, + "pow_a_sd": 2.0943271829959196, + "pow_ac50": 4.96063235721311, + "pow_p_sd": 0.11002382159571332, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 29513.6753956216, + "exp2_ac50": 25.04325193819569, + "exp2_b_sd": 86084.5411190017, + "exp3_a_sd": 150.0984224223333, + "exp3_ac50": 5.804399305999619, + "exp3_b_sd": 59137.001224216314, + "exp3_p_sd": 0.14658200866607235, + "exp4_ac50": 0.7837526624913668, + "exp5_ac50": 0.9532308456224, + "exp5_p_sd": 1.0630755148028903, + "gnls_ac50": 1.5013800743653127, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 0.8455244118283385, + "hill_p_sd": 3.878619687420101, + "poly1_aic": 62.445202743928206, + "poly1_cov": 1, + "poly1_rme": 10.006455332888448, + "poly1_top": 17.149562452326442, + "poly2_aic": 64.4652608512803, + "poly2_cov": 1, + "poly2_rme": 10.02747933976459, + "poly2_top": 16.783030687308678, + "pow_er_sd": 0.4080138155151314, + "exp2_er_sd": 0.3680437573619178, + "exp3_er_sd": 0.4222055989380574, + "exp4_er_sd": 0.39592940969417895, + "exp4_ga_sd": 0.31194015228918653, + "exp4_tp_sd": 1.6633876035629098, + "exp5_er_sd": 0.44034681277537735, + "exp5_ga_sd": 0.24033727643017272, + "exp5_tp_sd": 1.384891857432722, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.4472823050404181, + "hill_ga_sd": 0.2970999212415293, + "hill_tp_sd": 1.42857712990458, + "poly1_a_sd": 0.12552318478451832, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 17285.66623585318, + "poly2_ac50": 25.102605828879497, + "poly2_b_sd": 52518.880955116154, + "poly1_er_sd": 0.3680092384332859, + "poly2_er_sd": 0.36881665372257216, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 83.00745848531592 + }, + "mc5Param": { + "er": 0.829982332161024, + "ga": 0.7837526624913668, + "tp": 14.691482524381094, + "ac5": 0.057998152732469395, + "bmd": 1.1312085709028028, + "bmr": 9.289141683881516, + "mll": -21.343733797967744, + "top": 14.691482524381094, + "ac10": 0.11913282919448194, + "ac20": 0.25231200149874355, + "ac50": 0.7837526624913668, + "bmdl": 0.5939237424805409, + "bmdu": 2.1007406685525587, + "rmse": 4.18881846478536, + "ac1sd": 0.7151040430592887, + "caikwt": 0.00023320141532168285, + "hitcall": 0.00008838707536646198, + "top_over_cutoff": 0.6506181177291949 + }, + "mc6Param": { + "flag": [ + "Multiple points above baseline, inactive", + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 8, + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842402, + "spid": "DMSO", + "chid": null, + "casn": null, + "chnm": null, + "dtxsid": null, + "bmad": 3.7634679299683276, + "respMax": 29.154644659004813, + "respMin": -64.01776227967419, + "maxMean": -2.786975848040293, + "maxMeanConc": -2.0, + "maxMed": -1.8549943011561494, + "maxMedConc": -2.0, + "logcMax": -2.0, + "logcMin": -2.0, + "nconc": 1, + "npts": 60, + "nrep": 60.0, + "nmedGtbl": 0, + "tmpi": 1, + "m5id": 5037048, + "modl": "none", + "hitc": 0.0, + "fitc": 2, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": null, + "stkc": null, + "stkcUnit": null, + "testedConcUnit": null, + "mc3Param": { + "logc": [ + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2, + -2 + ], + "resp": [ + -11.154261912892895, + -0.3085213350118397, + -10.769705425508318, + 4.175375587545503, + -10.98141849274888, + -12.376517295353013, + 0, + -64.01776227967419, + 0, + 0, + 7.302396825405491, + -23.726740442131682, + 20.578950616404875, + -2.1637598929705573, + 8.221941787379146, + -3.3615951256467733, + -13.00838695625285, + 0, + -8.147282382442452, + -16.675358684435366, + -7.366722199083715, + -4.547070003657009, + 6.727984535614843, + -14.413034459122256, + -3.3130697596828527, + -4.033069414485719, + -15.264672272410884, + -11.574027922167316, + -1.8116084217961972, + -2.683274758192687, + 13.045441512530893, + 11.771596698177454, + 1.822950768406886, + -6.366163269382269, + 10.919639964829472, + 7.646339314405353, + -5.425526716521953, + -23.59240555574474, + 29.154644659004813, + -1.8983801805161016, + 0, + -13.802724260910109, + 4.979838314070986, + 8.416800860440848, + -0.2717465644121584, + 3.9578867653660548, + -1.1225186138635874, + -21.297944237672343, + 8.682142820122102, + 15.423542211616034, + -8.54044397300711, + 0, + -3.629592160884692, + 5.3958263838470995, + -9.059839600469063, + 17.31012973696578, + -18.631736544948375, + -6.017477029882166, + 9.453622918139667, + -0.8512450188087707 + ] + }, + "mc4Param": { + "pow_a": null, + "pow_p": null, + "exp2_a": null, + "exp2_b": null, + "exp3_a": null, + "exp3_b": null, + "exp3_p": null, + "exp5_p": null, + "gnls_p": null, + "gnls_q": null, + "hill_p": null, + "pow_er": null, + "cnst_er": null, + "exp2_er": null, + "exp3_er": null, + "exp4_er": null, + "exp4_ga": null, + "exp4_tp": null, + "exp5_er": null, + "exp5_ga": null, + "exp5_tp": null, + "gnls_er": null, + "gnls_ga": null, + "gnls_la": null, + "gnls_tp": null, + "hill_er": null, + "hill_ga": null, + "hill_tp": null, + "poly1_a": null, + "poly2_a": null, + "poly2_b": null, + "pow_aic": null, + "pow_cov": null, + "pow_rme": null, + "all_bmed": 0, + "cnst_aic": null, + "cnst_rme": null, + "exp2_aic": null, + "exp2_cov": null, + "exp2_rme": null, + "exp3_aic": null, + "exp3_cov": null, + "exp3_rme": null, + "exp4_aic": null, + "exp4_cov": null, + "exp4_rme": null, + "exp5_aic": null, + "exp5_cov": null, + "exp5_rme": null, + "gnls_aic": null, + "gnls_cov": null, + "gnls_rme": null, + "hill_aic": null, + "hill_cov": null, + "hill_rme": null, + "poly1_er": null, + "poly2_er": null, + "pow_a_sd": null, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp5_p_sd": null, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_p_sd": null, + "poly1_aic": null, + "poly1_cov": null, + "poly1_rme": null, + "poly2_aic": null, + "poly2_cov": null, + "poly2_rme": null, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": null, + "poly2_a_sd": null, + "poly2_b_sd": null, + "poly1_er_sd": null, + "poly2_er_sd": null, + "pow_success": null, + "cnst_success": null, + "exp2_success": null, + "exp3_success": null, + "exp4_success": null, + "exp5_success": null, + "gnls_success": null, + "hill_success": null, + "poly1_success": null, + "poly2_success": null + }, + "mc5Param": { + "bmr": 9.289141683881516, + "hitcall": 0 + }, + "mc6Param": null + }, + { + "aeid": 704, + "m4id": 1842404, + "spid": "LEGTV001C03", + "chid": 22162, + "casn": "1689-84-5", + "chnm": "Bromoxynil", + "dtxsid": "DTXSID3022162", + "bmad": 3.7634679299683276, + "respMax": 17.24432669518075, + "respMin": -16.748848993380015, + "maxMean": 17.24432669518075, + "maxMeanConc": -0.6989700043360187, + "maxMed": 17.24432669518075, + "maxMedConc": -0.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 1, + "tmpi": 3, + "m5id": 5037050, + "modl": "poly1", + "hitc": 0.0029920822873240717, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 1.6989700043360187, + -1.6989700043360187, + 0.3010299956639812, + 0.7781512503836436, + -1.154901959985743, + 1.3010299956639813, + -0.22184874961635637, + -0.6989700043360187 + ], + "resp": [ + 8.524600212493528, + 9.072860762252425, + -3.8916282997793408, + -10.455090309750185, + -10.227272727272725, + -16.748848993380015, + -3.3236167488489907, + 17.24432669518075 + ] + }, + "mc4Param": { + "pow_a": 1.725949077512417E-7, + "pow_p": 4.5253782558540285, + "exp2_a": 0.00001640418685242636, + "exp2_b": 3.8001515537909256, + "exp3_a": 12.90516865711751, + "exp3_b": 54.422945490831, + "exp3_p": 7.998344245445021, + "exp5_p": 7.999993694423218, + "gnls_p": 0.4241648347027184, + "gnls_q": 7.9998847670280355, + "hill_p": 7.999087698843317, + "pow_er": 2.2542985187481523, + "cnst_er": 2.323734743510376, + "exp2_er": 2.251755277558436, + "exp3_er": 2.253232239765138, + "exp4_er": 2.323771099104438, + "exp4_ga": 11.86923471702094, + "exp4_tp": 7.755465672199024E-8, + "exp5_er": 2.25311336300597, + "exp5_ga": 51.61988856711754, + "exp5_tp": 20.5725635581771, + "gnls_er": 2.232648918042158, + "gnls_ga": 0.011612337436387274, + "gnls_la": 0.3672143632370176, + "gnls_tp": 12.14436282748164, + "hill_er": 2.2521666902515927, + "hill_ga": 52.29053788518011, + "hill_tp": 20.688317160612986, + "poly1_a": 0.059264731838513336, + "poly2_a": 0.00008746164302267517, + "poly2_b": 0.17995434389891726, + "pow_aic": 67.60619394277374, + "pow_cov": 1, + "pow_rme": 10.63489778795089, + "pow_top": 8.423835804546373, + "all_bmed": 0, + "cnst_aic": 64.42755044014181, + "cnst_rme": 11.028222754070327, + "exp2_aic": 67.57203572586648, + "exp2_cov": 1, + "exp2_rme": 10.609032886271716, + "exp2_top": 8.494289345379501, + "exp3_aic": 69.57232094962438, + "exp3_cov": 1, + "exp3_rme": 10.60924696767611, + "exp3_top": 8.535257141972448, + "exp4_aic": 68.42755045762016, + "exp4_cov": 1, + "exp4_rme": 11.028222760170856, + "exp4_top": 7.755465672199024E-8, + "exp5_aic": 69.57309089671247, + "exp5_cov": 1, + "exp5_rme": 10.609830072861923, + "exp5_top": 20.5725635581771, + "gnls_aic": 73.41799184836066, + "gnls_cov": 1, + "gnls_rme": 10.614494151590849, + "gnls_top": 9.287173487099578, + "hill_aic": 69.57365995839154, + "hill_cov": 1, + "hill_rme": 10.610269740695813, + "hill_top": 20.688317160612986, + "poly1_er": 2.308829204544371, + "poly2_er": 2.2585407128453037, + "pow_a_sd": 0.0000018803876981312193, + "pow_ac50": 42.89924007169241, + "pow_p_sd": 0.2615425978878468, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 0.00006528915415492634, + "exp2_ac50": 47.36594300362757, + "exp2_b_sd": 1.1482590548973135, + "exp3_a_sd": null, + "exp3_ac50": 46.53251133220428, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 11.86923471702094, + "exp5_ac50": 51.61988856711754, + "exp5_p_sd": null, + "gnls_ac50": 0.003749285947936685, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 52.29053788518011, + "hill_p_sd": 34.94604828343594, + "poly1_aic": 66.3487573617917, + "poly1_cov": 1, + "poly1_rme": 11.07211531968513, + "poly1_top": 2.9632365919256665, + "poly2_aic": 67.91979710905, + "poly2_cov": 1, + "poly2_rme": 10.858529674694983, + "poly2_top": 6.776309423253431, + "pow_er_sd": 0.3074409916401629, + "exp2_er_sd": 0.3064920897367097, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.3066098414034118, + "hill_ga_sd": 433.0782348506896, + "hill_tp_sd": 798.217144794448, + "poly1_a_sd": 0.2008290041071431, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 0.001526277534281327, + "poly2_ac50": 35.32904249953417, + "poly2_b_sd": 1.5875043868026275, + "poly1_er_sd": 0.3041166431752558, + "poly2_er_sd": 0.3058854737291205, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.3727404712005974 + }, + "mc5Param": { + "a": 0.059264731838513336, + "er": 2.308829204544371, + "ac5": 2.4999999999999996, + "bmd": 156.73979103107902, + "bmr": 9.289141683881516, + "mll": -31.17437868089585, + "top": 2.9632365919256665, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 25.23802000566871, + "rmse": 11.07211531968513, + "ac1sd": 116.18961529360936, + "caikwt": 0.7232426117655388, + "hitcall": 0.0029920822873240717, + "top_over_cutoff": 0.13122810517083394 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842405, + "spid": "LEGTV001C05", + "chid": 20440, + "casn": "120-36-5", + "chnm": "Dichlorprop", + "dtxsid": "DTXSID0020440", + "bmad": 3.7634679299683276, + "respMax": 12.401136092711798, + "respMin": -8.612173606576068, + "maxMean": 12.401136092711798, + "maxMeanConc": -0.22184874961635637, + "maxMed": 12.401136092711798, + "maxMedConc": -0.22184874961635637, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 1, + "tmpi": 4, + "m5id": 5037051, + "modl": "exp5", + "hitc": 7.715427065113419E-15, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.6989700043360187, + 1.6989700043360187, + -0.22184874961635637, + -1.6989700043360187, + 0.7781512503836436, + -1.154901959985743, + 0.3010299956639812, + 1.3010299956639813 + ], + "resp": [ + 10.364772833286688, + 8.905785158234078, + 12.401136092711798, + -0.6942500855179268, + 10.618476018699921, + 0.6942500855179268, + -8.612173606576068, + 6.03652911237573 + ] + }, + "mc4Param": { + "pow_a": 3.121611710249508, + "pow_p": 0.300000440805151, + "exp2_a": 844.7352530391539, + "exp2_b": 4140.505458874806, + "exp3_a": 6.529613004062455, + "exp3_b": 62.365867529043086, + "exp3_p": 0.30000012065047343, + "exp5_p": 7.384612447046498, + "gnls_p": 7.998079908874962, + "gnls_q": 0.3000000007152951, + "hill_p": 7.999999550286872, + "pow_er": 1.7128917398097694, + "cnst_er": 2.064484274768512, + "exp2_er": 1.854098740521344, + "exp3_er": 1.7364617533808766, + "exp4_er": 1.3051553103733522, + "exp4_ga": 0.09070126641098608, + "exp4_tp": 8.97564962535527, + "exp5_er": 0.9338117444364008, + "exp5_ga": 0.09437221560468234, + "exp5_tp": 9.445184350204824, + "gnls_er": 0.5389629722138889, + "gnls_ga": 0.1650117092406103, + "gnls_la": 59.04702616089972, + "gnls_tp": 14.881363229750573, + "hill_er": 0.9350004825335526, + "hill_ga": 0.09546411869143644, + "hill_tp": 9.449887679873935, + "poly1_a": 0.20536815823136903, + "poly2_a": 687.7206271707939, + "poly2_b": 3402.532885448278, + "pow_aic": 59.62983960478393, + "pow_cov": 1, + "pow_rme": 6.671243317314767, + "pow_top": 10.094170392107534, + "all_bmed": 0, + "cnst_aic": 60.19666751493744, + "cnst_rme": 8.402789111634103, + "exp2_aic": 61.531032617462245, + "exp2_cov": 1, + "exp2_rme": 7.3615053364472125, + "exp2_top": 10.262711761047347, + "exp3_aic": 62.09365177604067, + "exp3_cov": 1, + "exp3_rme": 6.794901875497607, + "exp3_top": 10.116872077829878, + "exp4_aic": 56.12885991920658, + "exp4_cov": 1, + "exp4_rme": 6.681915704324382, + "exp4_top": 8.97564962535527, + "exp5_aic": 55.557492165112755, + "exp5_cov": 1, + "exp5_rme": 6.608895943346805, + "exp5_top": 9.445184350204824, + "gnls_aic": 57.520569181463856, + "gnls_cov": 1, + "gnls_rme": 6.998426262818015, + "gnls_top": 12.249786804248052, + "hill_aic": 55.56652951607745, + "hill_cov": 1, + "hill_rme": 6.610861943383319, + "hill_top": 9.449887679873935, + "poly1_er": 1.853314780351189, + "poly2_er": 1.8543795698394705, + "pow_a_sd": null, + "pow_ac50": 4.960645128343272, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": 14008.70342854903, + "exp2_ac50": 25.075473418488187, + "exp2_b_sd": 68253.83508399563, + "exp3_a_sd": null, + "exp3_ac50": 9.780888763356495, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 0.09070126641098608, + "exp5_ac50": 0.09437221560468234, + "exp5_p_sd": 269.96048261662713, + "gnls_ac50": 0.1635254438108516, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 0.09546411869143644, + "hill_p_sd": 14.519583400029104, + "poly1_aic": 59.527349525667354, + "poly1_cov": 1, + "poly1_rme": 7.360105587021132, + "poly1_top": 10.26840791156845, + "poly2_aic": 61.53621082274063, + "poly2_cov": 1, + "poly2_rme": 7.363476010280246, + "poly2_top": 10.254517159159812, + "pow_er_sd": null, + "exp2_er_sd": 0.31997257287398145, + "exp3_er_sd": null, + "exp4_er_sd": 0.370650678068716, + "exp4_ga_sd": 0.06239224387281597, + "exp4_tp_sd": 1.9164242059007173, + "exp5_er_sd": 0.431497487479637, + "exp5_ga_sd": 1.032106503926616, + "exp5_tp_sd": 1.3000343253660858, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.43172822082146006, + "hill_ga_sd": 0.05953029354685805, + "hill_tp_sd": 1.3057088570476094, + "poly1_a_sd": 0.10793537826384712, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 7498.910083446686, + "poly2_ac50": 25.181017025347085, + "poly2_b_sd": 36576.65297284068, + "poly1_er_sd": 0.31993419285597785, + "poly2_er_sd": 0.3199628347203704, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 194.37172917375648 + }, + "mc5Param": { + "p": 7.384612447046498, + "er": 0.9338117444364008, + "ga": 0.09437221560468234, + "tp": 9.445184350204824, + "ac5": 0.06633147903190056, + "bmd": 0.12006740302572848, + "bmr": 9.289141683881516, + "mll": -23.778746082556378, + "top": 9.445184350204824, + "ac10": 0.07312288030740835, + "ac20": 0.0809443375202312, + "ac50": 0.09437221560468234, + "bmdl": 0.08803437994217998, + "bmdu": 0.24201185048064888, + "rmse": 6.608895943346805, + "ac1sd": 0.10282304939527366, + "caikwt": 0.08951365853820019, + "hitcall": 7.715427065113419E-15, + "top_over_cutoff": 0.41828372686944937 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842406, + "spid": "LEGTV002C04", + "chid": 20442, + "casn": "94-75-7", + "chnm": "2,4-Dichlorophenoxyacetic acid", + "dtxsid": "DTXSID0020442", + "bmad": 3.7634679299683276, + "respMax": 6.370859881086669, + "respMin": -24.72241823635355, + "maxMean": 6.370859881086669, + "maxMeanConc": -1.6989700043360187, + "maxMed": 6.370859881086669, + "maxMedConc": -1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 5, + "m5id": 5037052, + "modl": "poly1", + "hitc": 0.002042012002651702, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.6989700043360187, + 1.6989700043360187, + 0.3010299956639812, + -1.6989700043360187, + 0.7781512503836436, + -1.154901959985743, + -0.22184874961635637, + 1.3010299956639813 + ], + "resp": [ + -21.311944042400853, + -24.72241823635355, + 4.233132626308943, + 6.370859881086669, + -2.027415652400837, + -6.370859881086669, + -24.42384722229375, + 4.914918420921617 + ] + }, + "mc4Param": { + "pow_a": 3.3072505400423485E-7, + "pow_p": 0.48940737393325506, + "exp2_a": 0.0001178398873513196, + "exp2_b": 63.34951489094878, + "exp3_a": 0.0001841064325533645, + "exp3_b": 55.65163739945494, + "exp3_p": 6.824418075268488, + "exp5_p": 7.707370645935452, + "gnls_p": 7.997415906240865, + "gnls_q": 7.989198554360788, + "hill_p": 2.571992160004071, + "pow_er": 2.5239488469935676, + "cnst_er": 2.5242223192710633, + "exp2_er": 2.525053668986501, + "exp3_er": 2.523884767735848, + "exp4_er": 2.5241938891100872, + "exp4_ga": 1.6515772735986691, + "exp4_tp": 6.617210716178248E-9, + "exp5_er": 2.524199907336932, + "exp5_ga": 10.178571517103231, + "exp5_tp": 5.172831559020237E-10, + "gnls_er": 2.5242279860451324, + "gnls_ga": 0.004183840961600125, + "gnls_la": 0.4674883095224845, + "gnls_tp": 1.1951706709070964E-9, + "hill_er": 2.524223618395549, + "hill_ga": 148.03344804359023, + "hill_tp": 2.733414071151221E-7, + "poly1_a": 3.75351162131322E-10, + "poly2_a": 0.00002346265382550711, + "poly2_b": 59.967965785150426, + "pow_aic": 72.58967090276546, + "pow_cov": 1, + "pow_rme": 14.955280470099757, + "pow_top": 0.0000022436522447587723, + "all_bmed": 0, + "cnst_aic": 68.58966978130083, + "cnst_rme": 14.955279986723223, + "exp2_aic": 72.58970163671296, + "exp2_cov": 1, + "exp2_rme": 14.95530781824828, + "exp2_top": 0.00014161915125562188, + "exp3_aic": 74.5896936496435, + "exp3_cov": 1, + "exp3_rme": 14.955303510350245, + "exp3_top": 0.00011387453660103208, + "exp4_aic": 72.58966979064168, + "exp4_cov": 1, + "exp4_rme": 14.955279988191776, + "exp4_top": 6.617210716178248E-9, + "exp5_aic": 74.58966978654288, + "exp5_cov": 1, + "exp5_rme": 14.955279986808964, + "exp5_top": 5.172831559020237E-10, + "gnls_aic": 78.58966978173339, + "gnls_cov": 0, + "gnls_rme": 14.955279986965122, + "gnls_top": 1.1951706553283066E-9, + "hill_aic": 74.58966978433192, + "hill_cov": 1, + "hill_rme": 14.955279989922763, + "hill_top": 2.733414071151221E-7, + "poly1_er": 2.524225595579482, + "poly2_er": 2.5192954625514083, + "pow_a_sd": null, + "pow_ac50": 12.13051274192964, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 29.809987412922897, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 45.922737651566834, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 1.6515772735986691, + "exp5_ac50": 10.178571517103231, + "exp5_p_sd": null, + "gnls_ac50": 0.004183841731103657, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 148.03344804359023, + "hill_p_sd": null, + "poly1_aic": 70.58966978459904, + "poly1_cov": 1, + "poly1_rme": 14.955279990364838, + "poly1_top": 1.8767558106566096E-8, + "poly2_aic": 72.58990187798537, + "poly2_cov": 1, + "poly2_rme": 14.95528704942522, + "poly2_top": 0.00003587357796415024, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.7543725426808853, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.416665901382313, + "poly2_b_sd": null, + "poly1_er_sd": 0.4477482735353781, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.46748831104898736 + }, + "mc5Param": { + "a": 3.75351162131322E-10, + "er": 2.524225595579482, + "ac5": 2.4999999999999996, + "bmd": 24747869784.486176, + "bmr": 9.289141683881516, + "mll": -33.29483489229952, + "top": 1.8767558106566096E-8, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 32.07314681587885, + "rmse": 14.955279990364838, + "ac1sd": 18345344540.019405, + "caikwt": 0.7310585789542388, + "hitcall": 0.002042012002651702, + "top_over_cutoff": 8.311287379883885E-10 + }, + "mc6Param": { + "flag": [ + "Model directionality questionable", + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 5, + 9, + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842407, + "spid": "LEGTV002C05", + "chid": 24159, + "casn": "82558-50-7", + "chnm": "Isoxaben", + "dtxsid": "DTXSID8024159", + "bmad": 3.7634679299683276, + "respMax": 5.49720635915255, + "respMin": -42.51947478602658, + "maxMean": 5.49720635915255, + "maxMeanConc": -1.6989700043360187, + "maxMed": 5.49720635915255, + "maxMedConc": -1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 6, + "m5id": 5037053, + "modl": "poly1", + "hitc": 0.005642489777948826, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.6989700043360187, + 1.6989700043360187, + -0.22184874961635637, + -1.6989700043360187, + 0.7781512503836436, + 0.3010299956639812, + -1.154901959985743, + 1.3010299956639813 + ], + "resp": [ + -25.365997806861397, + -17.548550487285034, + -34.678529552780105, + 5.49720635915255, + -33.60688227782604, + -42.51947478602658, + -5.497206359152553, + -17.438893556824596 + ] + }, + "mc4Param": { + "pow_a": 6.226170694933507E-8, + "pow_p": 0.4042163870931334, + "exp2_a": 0.0001012762858506541, + "exp2_b": 57.270518532764584, + "exp3_a": 0.0000182768161808948, + "exp3_b": 54.022410694191784, + "exp3_p": 6.142965107596046, + "exp5_p": 2.8793235821658465, + "gnls_p": 3.493285104003668, + "gnls_q": 7.031846474264492, + "hill_p": 1.0379684048996836, + "pow_er": 3.173306223014833, + "cnst_er": 3.173629962494881, + "exp2_er": 3.1736428876942693, + "exp3_er": 3.1731540297554797, + "exp4_er": 3.173621981878118, + "exp4_ga": 3.8258649261720423, + "exp4_tp": 3.8520423020123184E-9, + "exp5_er": 3.1736383043942484, + "exp5_ga": 2.271771952781368, + "exp5_tp": 5.262533058108749E-11, + "gnls_er": 3.1736202534985587, + "gnls_ga": 0.005952471727474193, + "gnls_la": 0.18861860617718257, + "gnls_tp": 1.6686711949450346E-7, + "hill_er": 3.17364751679775, + "hill_ga": 20.040557914497292, + "hill_tp": 1.1614522693913956E-8, + "poly1_a": 3.659932631449042E-9, + "poly2_a": 0.000013026598523821235, + "poly2_b": 57.387744641763376, + "pow_aic": 82.14157800030708, + "pow_cov": 1, + "pow_rme": 26.114813220190868, + "pow_top": 3.0267220450413394E-7, + "all_bmed": 0, + "cnst_aic": 78.14157681500255, + "cnst_rme": 26.114813127316296, + "exp2_aic": 82.14159084553305, + "exp2_cov": 1, + "exp2_rme": 26.114831275368346, + "exp2_top": 0.00014119949389863312, + "exp3_aic": 84.14158033084956, + "exp3_cov": 1, + "exp3_rme": 26.1148144541783, + "exp3_top": 0.000015755848523068117, + "exp4_aic": 82.14157681587226, + "exp4_cov": 1, + "exp4_rme": 26.11481312868518, + "exp4_top": 3.8520423020123184E-9, + "exp5_aic": 84.14157681658645, + "exp5_cov": 1, + "exp5_rme": 26.114813127337793, + "exp5_top": 5.262533058108749E-11, + "gnls_aic": 88.14157682092178, + "gnls_cov": 1, + "gnls_rme": 26.11481313545457, + "gnls_top": 1.6676819541873118E-7, + "hill_aic": 84.14157682143528, + "hill_cov": 1, + "hill_rme": 26.114813129178945, + "hill_top": 1.1614522693913956E-8, + "poly1_er": 3.1736110292974504, + "poly2_er": 3.177870228427013, + "pow_a_sd": null, + "pow_ac50": 9.000054430731787, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 30.29159091667016, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 45.711967424362975, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 3.8258649261720423, + "exp5_ac50": 2.271771952781368, + "exp5_p_sd": null, + "gnls_ac50": 0.0059504517433272355, + "gnls_p_sd": 224765.9170368504, + "gnls_q_sd": 180670.09083156497, + "hill_ac50": 20.040557914497292, + "hill_p_sd": null, + "poly1_aic": 80.14157683765278, + "poly1_cov": 1, + "poly1_rme": 26.114813154277936, + "poly1_top": 1.829966315724521E-7, + "poly2_aic": 82.14177676316693, + "poly2_cov": 1, + "poly2_rme": 26.11481578856423, + "poly2_top": 0.000021238186978110477, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": 0.3015548243048596, + "gnls_ga_sd": 485.41916773439993, + "gnls_la_sd": 289.43404331885483, + "gnls_tp_sd": 0.003781427130691287, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.6673078948731034, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.534768764417112, + "poly2_b_sd": null, + "poly1_er_sd": 0.4166433568135868, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.188650105801014 + }, + "mc5Param": { + "a": 3.659932631449042E-9, + "er": 3.1736110292974504, + "ac5": 2.5, + "bmd": 2538063570.9143515, + "bmr": 9.289141683881516, + "mll": -38.07078841882639, + "top": 1.829966315724521E-7, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 23.5430889035458, + "rmse": 26.114813154277936, + "ac1sd": 1881440749.3805425, + "caikwt": 0.7310585808566573, + "hitcall": 0.005642489777948826, + "top_over_cutoff": 8.104078249888357E-9 + }, + "mc6Param": { + "flag": [ + "Model directionality questionable", + "Bmd > ac50, indication of high baseline variability", + "Noisy data", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 5, + 9, + 10, + 13 + ] + } + } +] diff --git a/vignettes/api/0/api-ccte.epa.gov/bioactivity/data/search/by-dtxsid/DTXSID30944145.json b/vignettes/api/0/api-ccte.epa.gov/bioactivity/data/search/by-dtxsid/DTXSID30944145.json new file mode 100644 index 00000000..4ddd3f32 --- /dev/null +++ b/vignettes/api/0/api-ccte.epa.gov/bioactivity/data/search/by-dtxsid/DTXSID30944145.json @@ -0,0 +1,1064 @@ +[ + { + "aeid": 3094, + "m4id": 822141, + "spid": "ES211_47_47", + "chid": 944145, + "casn": "21535-47-7", + "chnm": "Mianserin hydrochloride", + "dtxsid": "DTXSID30944145", + "bmad": 6.75211217879369, + "respMax": 101.97489068160048, + "respMin": -5.852474808193342, + "maxMean": 101.28943947387002, + "maxMeanConc": 2.3010299956639813, + "maxMed": 101.164780328344, + "maxMedConc": 2.3010299956639813, + "logcMax": 2.3010299956639813, + "logcMin": -6.0, + "nconc": 9, + "npts": 36, + "nrep": 4.0, + "nmedGtbl": 3, + "tmpi": 42, + "m5id": 7598924, + "modl": "exp5", + "hitc": 0.9999999999966847, + "fitc": 42, + "coff": 20.25633653638107, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 100.0, + "stkcUnit": null, + "testedConcUnit": null, + "mc3Param": { + "logc": [ + -0.3010299956639812, + -3, + 2.3010299956639813, + 1.9030899869919435, + 0.6989700043360189, + 0.6989700043360189, + -1.3010299956639813, + -6, + 2.3010299956639813, + 1.4771212547196624, + 1, + 1.4771212547196624, + 1, + -1.3010299956639813, + -0.3010299956639812, + -3, + -6, + 1.9030899869919435, + 1.9030899869919435, + 1, + 1.4771212547196624, + -0.3010299956639812, + 0.6989700043360189, + -1.3010299956639813, + -3, + 2.3010299956639813, + 1.4771212547196624, + 1.9030899869919435, + 0.6989700043360189, + -0.3010299956639812, + -1.3010299956639813, + -6, + 2.3010299956639813, + -6, + 1, + -3 + ], + "resp": [ + 7.427232859032931, + -3.750051787305786, + 101.07307228396438, + 98.9002717861462, + 17.02699226830727, + 17.699805850864504, + 2.9964941201219695, + -2.3418378029464026, + 100.8533065571916, + 58.64570278003023, + 5.964872358375655, + 49.11565073337273, + 14.83512968293488, + -3.9755251250928403, + 8.861038251024265, + -2.503018132836884, + 10.01979188930157, + 99.31356213766618, + 101.39305781992614, + 19.77117858122105, + 52.084973469960936, + 6.965386514618434, + 12.337528884815498, + -5.852474808193342, + 2.4837211637883, + 101.25648837272361, + 45.27350419250797, + 101.25648837272361, + 10.373412937556623, + 8.43972728547434, + -3.9875658920796426, + 1.7693315847934825, + 101.97489068160048, + 14.296296110011324, + 6.899162035880055, + -0.9777667971902465 + ] + }, + "mc4Param": { + "pow_a": 8.980263423505296, + "pow_p": 0.4658605032164628, + "exp2_a": 20906.920443662984, + "exp2_b": 38271.293496514474, + "exp3_a": 1485.9514343897358, + "exp3_b": 65459.19750014387, + "exp3_p": 0.46157030104511454, + "exp5_p": 1.4598137263404865, + "gnls_p": 2.0882292940940737, + "gnls_q": 7.993467618938603, + "hill_p": 2.08823290079987, + "pow_er": 2.153005726183071, + "cnst_er": 3.5592259949766554, + "exp2_er": 2.6995029704246463, + "exp3_er": 2.1600743867360332, + "exp4_er": 1.7944788900032378, + "exp4_ga": 28.42183560284198, + "exp4_tp": 105.35849603526988, + "exp5_er": 1.6323860710514544, + "exp5_ga": 29.136304634949504, + "exp5_tp": 102.86194850536708, + "gnls_er": 1.7852653451471712, + "gnls_ga": 29.224488415897408, + "gnls_la": 3787.921673603752, + "gnls_tp": 106.40480941826632, + "hill_er": 1.785256872105232, + "hill_ga": 29.22430650665218, + "hill_tp": 106.40450294071316, + "poly1_a": 0.5474828009413533, + "poly2_a": 27146.761600523227, + "poly2_b": 49818.73895889866, + "pow_aic": 286.2961627225351, + "pow_cov": 1, + "pow_rme": 12.749288084437351, + "pow_top": 105.98589412140464, + "all_bmed": 0, + "cnst_aic": 384.3251737754444, + "cnst_rme": 51.114626158662446, + "exp2_aic": 328.2752622937805, + "exp2_cov": 1, + "exp2_rme": 23.28731820786984, + "exp2_top": 109.54238551681884, + "exp3_aic": 288.7695452039763, + "exp3_cov": 1, + "exp3_rme": 12.853976257861472, + "exp3_top": 106.23398734408596, + "exp4_aic": 252.15096836877743, + "exp4_cov": 1, + "exp4_rme": 7.153206032224669, + "exp4_top": 105.35849603526988, + "exp5_aic": 242.37818996364612, + "exp5_cov": 1, + "exp5_rme": 6.04671272377595, + "exp5_top": 102.86194850536708, + "gnls_aic": 256.43287140229086, + "gnls_cov": 1, + "gnls_rme": 6.883032818734613, + "gnls_top": 106.3485222050823, + "hill_aic": 252.43287141156785, + "hill_cov": 1, + "hill_rme": 6.883035058943881, + "hill_top": 106.40450294071316, + "poly1_er": 2.698231249887153, + "poly2_er": 2.69823328798644, + "pow_a_sd": 1.6459870762064353, + "pow_ac50": 45.16993304352483, + "pow_p_sd": 0.0359070833296379, + "all_onesd": 13.177463361669563, + "exp2_a_sd": 80054.91579295504, + "exp2_ac50": 100.13064607578782, + "exp2_b_sd": 146042.59634222218, + "exp3_a_sd": 1557.2108093448396, + "exp3_ac50": 46.23219211065147, + "exp3_b_sd": 126993.03927633302, + "exp3_p_sd": 0.04175006048618471, + "exp4_ac50": 28.42183560284198, + "exp5_ac50": 29.136304634949504, + "exp5_p_sd": 0.16077431744640758, + "gnls_ac50": 29.209685841672393, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 29.22430650665218, + "hill_p_sd": 0.3854703745468205, + "poly1_aic": 326.2063457159531, + "poly1_cov": 1, + "poly1_rme": 23.266335897780746, + "poly1_top": 109.49656018827066, + "poly2_aic": 328.3117909623189, + "poly2_cov": 1, + "poly2_rme": 23.312627580644826, + "poly2_top": 109.41964530134416, + "pow_er_sd": 0.17588811957512163, + "exp2_er_sd": 0.18414085537434977, + "exp3_er_sd": 0.17616560477044965, + "exp4_er_sd": 0.14951537674258722, + "exp4_ga_sd": 2.504500211345132, + "exp4_tp_sd": 3.090966159056836, + "exp5_er_sd": 0.1494114951654834, + "exp5_ga_sd": 1.6840648875294664, + "exp5_tp_sd": 2.1361083422870157, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.14832567590990886, + "hill_ga_sd": 1.96787729051603, + "hill_tp_sd": 3.504225659847863, + "poly1_a_sd": 0.039187291314295165, + "poly1_ac50": 100, + "poly2_a_sd": 84355.29653483114, + "poly2_ac50": 100.1999242731534, + "poly2_b_sd": 154185.56825938867, + "poly1_er_sd": 0.1840572310279764, + "poly2_er_sd": 0.18411448898547148, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 3788.3863573521858 + }, + "mc5Param": { + "p": 1.4598137263404865, + "er": 1.6323860710514544, + "ga": 29.136304634949504, + "tp": 102.86194850536708, + "ac5": 4.895974620693649, + "acc": 13.246002431318528, + "bmd": 11.994507756086188, + "bmr": 17.776398074892242, + "mll": -117.18909498182306, + "top": 102.86194850536708, + "ac10": 8.01655754617927, + "ac20": 13.404172123946616, + "ac50": 29.136304634949504, + "bmdl": 11.03986268985668, + "bmdu": 12.963072648031766, + "rmse": 6.04671272377595, + "ac1sd": 9.600739034050022, + "caikwt": 1.5017723494623147E-31, + "hitcall": 0.9999999999966848, + "top_over_cutoff": 5.078013406847952 + }, + "mc6Param": null + }, + { + "aeid": 3098, + "m4id": 822345, + "spid": "ES211_47_47", + "chid": 944145, + "casn": "21535-47-7", + "chnm": "Mianserin hydrochloride", + "dtxsid": "DTXSID30944145", + "bmad": 6.292361272058492, + "respMax": 98.60944617597698, + "respMin": -15.487892591704627, + "maxMean": 97.61114262807376, + "maxMeanConc": 2.3010299956639813, + "maxMed": 97.67386193907646, + "maxMedConc": 2.3010299956639813, + "logcMax": 2.3010299956639813, + "logcMin": -6.0, + "nconc": 9, + "npts": 36, + "nrep": 4.0, + "nmedGtbl": 3, + "tmpi": 42, + "m5id": 7599128, + "modl": "exp5", + "hitc": 0.9999999999589282, + "fitc": 42, + "coff": 18.877083816175475, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 100.0, + "stkcUnit": null, + "testedConcUnit": null, + "mc3Param": { + "logc": [ + -6, + 1.4771212547196624, + -1.3010299956639813, + -3, + 1.9030899869919435, + 1.9030899869919435, + 1.4771212547196624, + -0.3010299956639812, + 0.6989700043360189, + -1.3010299956639813, + -3, + 2.3010299956639813, + 1.4771212547196624, + 0.6989700043360189, + -0.3010299956639812, + -1.3010299956639813, + -6, + 2.3010299956639813, + 1, + -3, + 0.6989700043360189, + 1.4771212547196624, + -0.3010299956639812, + -3, + 2.3010299956639813, + 1.9030899869919435, + 1, + 0.6989700043360189, + -1.3010299956639813, + 2.3010299956639813, + 1.9030899869919435, + 1, + 1, + -0.3010299956639812, + -6, + -6 + ], + "resp": [ + -15.487892591704627, + 40.445936226324626, + -3.308559098537521, + 2.4871891013623295, + 95.05061867266592, + 94.2402094469292, + 41.223955492527544, + 13.285839270091238, + 12.403185338714955, + 5.966930265995686, + 3.2590462497004555, + 97.74742391564821, + 37.58280214973128, + 13.203930026359934, + 1.8653867132104287, + 7.428820770153813, + -0.5751258087706687, + 96.48740045816517, + 10.046907385185994, + 6.577942620268354, + 0.2397506593143131, + 45.626647495806374, + 10.740829537281229, + 3.4763845600575403, + 98.60944617597698, + 96.61951570366818, + 36.849676336609924, + 25.084364454443193, + 14.135733033370828, + 97.60029996250469, + 94.17685118619698, + 5.586801649793776, + 16.462976276060388, + 6.709801102324467, + -0.6374203224596925, + 4.330751609032399 + ] + }, + "mc4Param": { + "pow_a": 8.718852311483452, + "pow_p": 0.4621192452087188, + "exp2_a": 30733.63862806683, + "exp2_b": 58053.22582237376, + "exp3_a": 95.1637174921906, + "exp3_b": 487.2146854984712, + "exp3_p": 0.36448949067095376, + "exp5_p": 1.5921607117432042, + "gnls_p": 2.5006151066661264, + "gnls_q": 7.884701749657575, + "hill_p": 2.5005615803454724, + "pow_er": 2.1386687105738353, + "cnst_er": 3.5130386164195015, + "exp2_er": 2.6970289699940606, + "exp3_er": 2.2185744921064368, + "exp4_er": 2.011051198182322, + "exp4_ga": 32.650308081937, + "exp4_tp": 102.35617680593612, + "exp5_er": 1.7482328153387492, + "exp5_ga": 33.60823929102817, + "exp5_tp": 99.05623958289912, + "gnls_er": 1.8712349808607216, + "gnls_ga": 33.56038699307263, + "gnls_la": 5782.338770572877, + "gnls_tp": 101.44815858342024, + "hill_er": 1.8712200758466104, + "hill_ga": 33.56045811387879, + "hill_tp": 101.4484696652948, + "poly1_a": 0.5305416047533859, + "poly2_a": 27673.0817955942, + "poly2_b": 52368.24882950644, + "pow_aic": 284.11914879686157, + "pow_cov": 1, + "pow_rme": 12.167746147199564, + "pow_top": 100.8810435335372, + "all_bmed": 0, + "cnst_aic": 380.5440532323087, + "cnst_rme": 48.52148017787647, + "exp2_aic": 324.77731273488877, + "exp2_cov": 1, + "exp2_rme": 21.596356868481895, + "exp2_top": 106.06349428140288, + "exp3_aic": 288.16578474486806, + "exp3_cov": 1, + "exp3_rme": 12.654705150741076, + "exp3_top": 100.90413703157488, + "exp4_aic": 266.6070682545724, + "exp4_cov": 1, + "exp4_rme": 8.542515933428906, + "exp4_top": 102.35617680593612, + "exp5_aic": 257.6591381302885, + "exp5_cov": 1, + "exp5_rme": 8.397684028922718, + "exp5_top": 99.05623958289912, + "gnls_aic": 269.9181398445775, + "gnls_cov": 1, + "gnls_rme": 9.43263682314636, + "gnls_top": 101.43815067391468, + "hill_aic": 265.9181398398791, + "hill_cov": 1, + "hill_rme": 9.432603290521724, + "hill_top": 101.4484696652948, + "poly1_er": 2.6974150875559637, + "poly2_er": 2.6974910028623347, + "pow_a_sd": 1.6532680814195877, + "pow_ac50": 44.62909211616844, + "pow_p_sd": 0.037632545643377605, + "all_onesd": 13.014601637003002, + "exp2_a_sd": 144770.52933512983, + "exp2_ac50": 100.08612781558456, + "exp2_b_sd": 273004.74414100195, + "exp3_a_sd": 144.74203282152968, + "exp3_ac50": 46.69029054309706, + "exp3_b_sd": 1335.7880545481178, + "exp3_p_sd": 0.09938750851619732, + "exp4_ac50": 32.650308081937, + "exp5_ac50": 33.60823929102817, + "exp5_p_sd": 0.1861700465060868, + "gnls_ac50": 33.55773915040644, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 33.56045811387879, + "hill_p_sd": 0.6962069108870773, + "poly1_aic": 322.7320181754561, + "poly1_cov": 1, + "poly1_rme": 21.576688972834244, + "poly1_top": 106.10832095067718, + "poly2_aic": 324.83200434183965, + "poly2_cov": 1, + "poly2_rme": 21.612975364548863, + "poly2_top": 106.09011722019908, + "pow_er_sd": 0.17201036124649297, + "exp2_er_sd": 0.1724789031231027, + "exp3_er_sd": 0.1778243849070398, + "exp4_er_sd": 0.14816738537311727, + "exp4_ga_sd": 3.8800102860948154, + "exp4_tp_sd": 3.881300977472912, + "exp5_er_sd": 0.16675857577462103, + "exp5_ga_sd": 1.909160862868152, + "exp5_tp_sd": 2.442228657418365, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.16807331852131832, + "hill_ga_sd": 1.9630919114427805, + "hill_tp_sd": 4.0603354568457, + "poly1_a_sd": 0.03909925746514938, + "poly1_ac50": 100, + "poly2_a_sd": 88278.60946926908, + "poly2_ac50": 100.190228208773, + "poly2_b_sd": 166328.9016942867, + "poly1_er_sd": 0.17246325393606268, + "poly2_er_sd": 0.1725193110812217, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 5782.479713707603 + }, + "mc5Param": { + "p": 1.5921607117432042, + "er": 1.7482328153387492, + "ga": 33.60823929102817, + "tp": 99.05623958289912, + "ac5": 6.549950475444407, + "acc": 15.942801656366925, + "bmd": 15.15768602592679, + "bmr": 17.556697608317048, + "mll": -124.82956906514426, + "top": 99.05623958289912, + "ac10": 10.294039781041006, + "ac20": 16.492264340792413, + "ac50": 33.60823929102817, + "bmdl": 13.9632920083894, + "bmdu": 16.36542533906654, + "rmse": 8.397684028922718, + "ac1sd": 12.353374802821008, + "caikwt": 2.0695681448366308E-27, + "hitcall": 0.9999999999589282, + "top_over_cutoff": 5.24743337199252 + }, + "mc6Param": null + }, + { + "aeid": 3095, + "m4id": 1150437, + "spid": "ES211_47_47", + "chid": 944145, + "casn": "21535-47-7", + "chnm": "Mianserin hydrochloride", + "dtxsid": "DTXSID30944145", + "bmad": 0.1635842394403502, + "respMax": 11.45832139758188, + "respMin": 0.04981319925745456, + "maxMean": 4.937025241580714, + "maxMeanConc": 1.9030899869919435, + "maxMed": 5.454860652403362, + "maxMedConc": 1.9030899869919435, + "logcMax": 2.3010299956639813, + "logcMin": -6.0, + "nconc": 9, + "npts": 36, + "nrep": 4.0, + "nmedGtbl": 2, + "tmpi": 42, + "m5id": 7598992, + "modl": "exp5", + "hitc": 0.9999998831449819, + "fitc": 42, + "coff": 0.4907527183210506, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 100.0, + "stkcUnit": null, + "testedConcUnit": null, + "mc3Param": { + "logc": [ + -0.3010299956639812, + -1.3010299956639813, + 2.3010299956639813, + 0.6989700043360189, + -0.3010299956639812, + -6, + 2.3010299956639813, + 1, + -3, + 0.6989700043360189, + 1.4771212547196624, + -0.3010299956639812, + -3, + 2.3010299956639813, + 1.9030899869919435, + 1, + 0.6989700043360189, + -1.3010299956639813, + -6, + 2.3010299956639813, + 1.4771212547196624, + 1.9030899869919435, + 1, + 1, + -1.3010299956639813, + -0.3010299956639812, + -3, + -6, + 1.9030899869919435, + -6, + 1.9030899869919435, + 1.4771212547196624, + 0.6989700043360189, + -3, + 1.4771212547196624, + -1.3010299956639813 + ], + "resp": [ + 0.2882675039415536, + 0.2293577923201378, + 2.12765731100286, + 0.2760905500803271, + 0.2223210266269225, + 0.2859185064112817, + 3.726705759810087, + 0.169779282809137, + 0.2335357255129443, + 0.3364575742259655, + 0.2644336595666082, + 1.101262393197357, + 0.4222553297999173, + 1.724134958388003, + 6.3829741964722, + 0.1518602827691616, + 0.500500483800451, + 0.4657932906610395, + 0.6850736830999858, + 11.45832139758188, + 0.362318825993606, + 4.526747108334523, + 0.2382843463520162, + 0.22948937953272, + 0.3481086018076444, + 0.3596198212273357, + 0.461420136851573, + 0.5216095250469567, + 6.565653249670075, + 0.2280501658369403, + 2.272726411846056, + 0.3340757114300033, + 0.04981319925745456, + 0.222937819595298, + 0.4805766727842742, + 0.1649776062932452 + ] + }, + "mc4Param": { + "pow_a": 0.07306340900696351, + "pow_p": 0.6909308897469263, + "exp2_a": 489.25456473992574, + "exp2_b": 30770.895494055152, + "exp3_a": 16.86144381389201, + "exp3_b": 2819.131595534077, + "exp3_p": 0.6927530157131045, + "exp5_p": 4.565817027769467, + "gnls_p": 7.955761313099027, + "gnls_q": 0.5644747159243586, + "hill_p": 7.999999975199726, + "pow_er": -0.4956759683416578, + "cnst_er": -0.06367288253941095, + "exp2_er": -0.4920846292443089, + "exp3_er": -0.4952315996998395, + "exp4_er": -0.48780818578433305, + "exp4_ga": 62.936593572598966, + "exp4_tp": 3.160545685691406, + "exp5_er": -0.5427393909605482, + "exp5_ga": 45.24973438082952, + "exp5_tp": 3.6092716297582976, + "gnls_er": -0.5743685279270239, + "gnls_ga": 40.39441528906965, + "gnls_la": 1277.3835717446193, + "gnls_tp": 4.9743882398250925, + "hill_er": -0.5418420584767905, + "hill_ga": 39.362832742773776, + "hill_tp": 3.598558047969296, + "poly1_a": 0.015951258753982463, + "poly2_a": 689.1656998074085, + "poly2_b": 43422.635840414565, + "pow_aic": 119.27110226117928, + "pow_cov": 1, + "pow_rme": 1.970612708065348, + "pow_top": 2.841532541460785, + "all_bmed": 0, + "cnst_aic": 147.02320231677632, + "cnst_rme": 2.7213080260384577, + "exp2_aic": 121.536640649848, + "exp2_cov": 1, + "exp2_rme": 1.9806070196866243, + "exp2_top": 3.190339433218957, + "exp3_aic": 121.41570410348348, + "exp3_cov": 1, + "exp3_rme": 1.964500358062248, + "exp3_top": 2.9245335937115775, + "exp4_aic": 117.40649569667184, + "exp4_cov": 1, + "exp4_rme": 1.9143914875326904, + "exp4_top": 3.160545685691406, + "exp5_aic": 108.69371063135708, + "exp5_cov": 1, + "exp5_rme": 1.5839688744886915, + "exp5_top": 3.6092716297582976, + "gnls_aic": 110.23531348142146, + "gnls_cov": 1, + "gnls_rme": 1.540743257946914, + "gnls_top": 4.114035106463596, + "hill_aic": 108.7802965738098, + "hill_cov": 1, + "hill_rme": 1.5870073319060576, + "hill_top": 3.598558047969296, + "poly1_er": -0.49322275683035666, + "poly2_er": -0.4931857994848398, + "pow_a_sd": 0.06098198965840179, + "pow_ac50": 73.34025784745266, + "pow_p_sd": 0.17664309055759367, + "all_onesd": 0.8923597763803547, + "exp2_a_sd": 3184.6202015618323, + "exp2_ac50": 100.16249092262407, + "exp2_b_sd": 199490.5906912948, + "exp3_a_sd": 58.61911836048125, + "exp3_ac50": 77.81121531926684, + "exp3_b_sd": 9986.108641207353, + "exp3_p_sd": 0.29683220702002194, + "exp4_ac50": 62.936593572598966, + "exp5_ac50": 45.24973438082952, + "exp5_p_sd": 4.213044861329193, + "gnls_ac50": 39.827322985728394, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 39.362832742773776, + "hill_p_sd": 5.573024297626113, + "poly1_aic": 119.51285294787452, + "poly1_cov": 1, + "poly1_rme": 1.9801146542527, + "poly1_top": 3.190251750796493, + "poly2_aic": 121.54640180031528, + "poly2_cov": 1, + "poly2_rme": 1.981069269414523, + "poly2_top": 3.1888433746628246, + "pow_er_sd": 0.19875859625257855, + "exp2_er_sd": 0.19669797020202764, + "exp3_er_sd": 0.19724985616593993, + "exp4_er_sd": 0.1965661043023219, + "exp4_ga_sd": 34.81821712492219, + "exp4_tp_sd": 1.0390395652442248, + "exp5_er_sd": 0.1840458110753714, + "exp5_ga_sd": 16.99176937771065, + "exp5_tp_sd": 0.663162309702829, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.18392569712837312, + "hill_ga_sd": 7.865147277595785, + "hill_tp_sd": 0.6707173101135189, + "poly1_a_sd": 0.003422826182028237, + "poly1_ac50": 100, + "poly2_a_sd": 3794.628359530953, + "poly2_ac50": 100.2292375794687, + "poly2_b_sd": 237831.70254565787, + "poly1_er_sd": 0.19659363721503492, + "poly2_er_sd": 0.196607292096659, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 2372.2570284464873 + }, + "mc5Param": { + "p": 4.565817027769467, + "er": -0.5427393909605482, + "ga": 45.24973438082952, + "tp": 3.6092716297582976, + "ac5": 25.583338192735063, + "acc": 32.177479924985796, + "bmd": 40.242151032551405, + "bmr": 1.2037933383370985, + "mll": -50.346855315678546, + "top": 3.6092716297582976, + "ac10": 29.9520321053751, + "ac20": 35.30253965284071, + "ac50": 45.24973438082952, + "bmdl": 33.264446410375136, + "bmdu": 53.793763933888144, + "rmse": 1.5839688744886915, + "ac1sd": 37.21757330690621, + "caikwt": 4.751783349020907E-9, + "hitcall": 0.999999883144982, + "top_over_cutoff": 7.354562685065171 + }, + "mc6Param": { + "flag": [ + "Noisy data" + ], + "mc6MthdId": [ + 10 + ] + } + }, + { + "aeid": 3096, + "m4id": 1150505, + "spid": "ES211_47_47", + "chid": 944145, + "casn": "21535-47-7", + "chnm": "Mianserin hydrochloride", + "dtxsid": "DTXSID30944145", + "bmad": 0.257990171134824, + "respMax": 12.49998697918023, + "respMin": 0.0, + "maxMean": 5.541738410783121, + "maxMeanConc": 2.3010299956639813, + "maxMed": 4.833483331976126, + "maxMedConc": 2.3010299956639813, + "logcMax": 2.3010299956639813, + "logcMin": -6.0, + "nconc": 9, + "npts": 36, + "nrep": 4.0, + "nmedGtbl": 7, + "tmpi": 42, + "m5id": 7599060, + "modl": "exp5", + "hitc": 0.9999998559756664, + "fitc": 42, + "coff": 0.7739705134044719, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 100.0, + "stkcUnit": null, + "testedConcUnit": null, + "mc3Param": { + "logc": [ + 1.9030899869919435, + -1.3010299956639813, + 2.3010299956639813, + -6, + -0.3010299956639812, + -3, + 2.3010299956639813, + 1.9030899869919435, + 0.6989700043360189, + 0.6989700043360189, + -1.3010299956639813, + -6, + 2.3010299956639813, + 1.4771212547196624, + 1, + 1.4771212547196624, + 1, + -1.3010299956639813, + -0.3010299956639812, + -3, + -6, + 1.9030899869919435, + 1.9030899869919435, + 1, + 1.4771212547196624, + -0.3010299956639812, + 0.6989700043360189, + -1.3010299956639813, + -3, + 2.3010299956639813, + 1.4771212547196624, + 0.6989700043360189, + -0.3010299956639812, + -6, + 1, + -3 + ], + "resp": [ + 4.526747108334523, + 0.824888031466226, + 4.347823386445102, + 0.4561003316738806, + 0.7789416927493502, + 0.8941877572233543, + 0, + 5.673754841308623, + 1.057438090424463, + 1.601601548161443, + 0.7860261779905042, + 1.266348323306034, + 12.49998697918023, + 0.5233494153240975, + 0.6619009620889339, + 0.3966504893499123, + 0.6597819661565701, + 0.7658389239768177, + 0.8219881628053387, + 0.7946680134665979, + 1.341281635835031, + 5.050502499746212, + 3.030301882461408, + 0.9870918379995505, + 0.7423904698444517, + 0.9801095134012823, + 0.2988791955447274, + 0.6880733769604134, + 0.916522147225114, + 5.319143277507151, + 0.8810572334378359, + 0.7454444852168833, + 0.5113383612419217, + 1.119847483444187, + 0.5093378484274108, + 0.4670714510258886 + ] + }, + "mc4Param": { + "pow_a": 0.256129166457669, + "pow_p": 0.5644406772111492, + "exp2_a": 1129.3096760444655, + "exp2_b": 39317.04061124209, + "exp3_a": 0.8720019016302841, + "exp3_b": 22.670011403864912, + "exp3_p": 0.30000305864361876, + "exp5_p": 3.190253095690696, + "gnls_p": 4.264093872089519, + "gnls_q": 0.6791167117000405, + "hill_p": 7.176325755057048, + "pow_er": -0.034773780653756595, + "cnst_er": 0.3936756503357535, + "exp2_er": 0.049717571642521746, + "exp3_er": -0.06866643163594202, + "exp4_er": -0.0334255933863206, + "exp4_ga": 54.83941521805386, + "exp4_tp": 5.528448444550952, + "exp5_er": -0.12470418879335174, + "exp5_ga": 47.982496654915074, + "exp5_tp": 4.7906449817634, + "gnls_er": -0.123418231619115, + "gnls_ga": 48.10588765537344, + "gnls_la": 1521.241791470397, + "gnls_tp": 5.939435678991746, + "hill_er": -0.12226946714558153, + "hill_ga": 38.87908122770836, + "hill_tp": 4.727067329887222, + "poly1_a": 0.028809872811533375, + "poly2_a": 1571.4797602650003, + "poly2_b": 54739.707244964055, + "pow_aic": 131.0854979041203, + "pow_cov": 1, + "pow_rme": 1.7655265144654924, + "pow_top": 5.096288028509811, + "all_bmed": 0, + "cnst_aic": 163.6015491080996, + "cnst_rme": 2.940288361762558, + "exp2_aic": 137.69447001575364, + "exp2_cov": 1, + "exp2_rme": 1.8398294934860109, + "exp2_top": 5.759267997099814, + "exp3_aic": 132.21816633784778, + "exp3_cov": 1, + "exp3_rme": 1.7676923268681453, + "exp3_top": 5.085763779463437, + "exp4_aic": 129.8610022030918, + "exp4_cov": 1, + "exp4_rme": 1.7411782753483664, + "exp4_top": 5.528448444550952, + "exp5_aic": 126.4266045032358, + "exp5_cov": 1, + "exp5_rme": 1.7108365520435371, + "exp5_top": 4.7906449817634, + "gnls_aic": 130.5159804184214, + "gnls_cov": 1, + "gnls_rme": 1.71478488931515, + "gnls_top": 4.942677854612155, + "hill_aic": 126.56736784290752, + "hill_cov": 1, + "hill_rme": 1.7154496972433324, + "hill_top": 4.727067329887222, + "poly1_er": 0.048751930612820536, + "poly2_er": 0.04920885674061179, + "pow_a_sd": 0.1568794096944919, + "pow_ac50": 58.57409370876723, + "pow_p_sd": 0.12743956516601432, + "all_onesd": 0.40082905954467335, + "exp2_a_sd": 6523.3330851199225, + "exp2_ac50": 100.1271711840828, + "exp2_b_sd": 226568.13671898856, + "exp3_a_sd": null, + "exp3_ac50": 63.9739161348579, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 54.83941521805386, + "exp5_ac50": 47.982496654915074, + "exp5_p_sd": 1.6269771671859927, + "gnls_ac50": 46.104045082264136, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 38.87908122770836, + "hill_p_sd": 78.09046476767209, + "poly1_aic": 135.66432541001384, + "poly1_cov": 1, + "poly1_rme": 1.839223539922158, + "poly1_top": 5.761974562306676, + "poly2_aic": 137.70745803349075, + "poly2_cov": 1, + "poly2_rme": 1.8399012025826664, + "poly2_top": 5.762622726294994, + "pow_er_sd": 0.16005952572503318, + "exp2_er_sd": 0.16512363320736548, + "exp3_er_sd": null, + "exp4_er_sd": 0.1553647531392489, + "exp4_ga_sd": 22.623173556633372, + "exp4_tp_sd": 1.0746491215089478, + "exp5_er_sd": 0.1550298307298998, + "exp5_ga_sd": 11.027654963611443, + "exp5_tp_sd": 0.5822266175525593, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.15517480648449222, + "hill_ga_sd": 110.91755377399213, + "hill_tp_sd": 1.3037185004938374, + "poly1_a_sd": 0.004437974865094146, + "poly1_ac50": 100, + "poly2_a_sd": 7620.57224036576, + "poly2_ac50": 100.18201711241991, + "poly2_b_sd": 264301.4890716433, + "poly1_er_sd": 0.1650477137056485, + "poly2_er_sd": 0.16508964434676754, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 2505.4734619566725 + }, + "mc5Param": { + "p": 3.190253095690696, + "er": -0.12470418879335174, + "ga": 47.982496654915074, + "tp": 4.7906449817634, + "ac5": 21.21481348706796, + "acc": 31.23504395850078, + "bmd": 27.67407473473264, + "bmr": 0.5407184013257643, + "mll": -59.213302251617904, + "top": 4.7906449817634, + "ac10": 26.584628460854177, + "ac20": 33.634697200724105, + "ac50": 47.982496654915074, + "bmdl": 21.832233757697352, + "bmdu": 34.85027881622872, + "rmse": 1.7108365520435371, + "ac1sd": 25.06997712418609, + "caikwt": 8.463760056913385E-9, + "hitcall": 0.9999998559756664, + "top_over_cutoff": 6.18969960585545 + }, + "mc6Param": { + "flag": [ + "Noisy data" + ], + "mc6MthdId": [ + 10 + ] + } + } +] diff --git a/vignettes/api/0/api-ccte.epa.gov/bioactivity/data/search/by-m4id/1842443.json b/vignettes/api/0/api-ccte.epa.gov/bioactivity/data/search/by-m4id/1842443.json new file mode 100644 index 00000000..dff7f002 --- /dev/null +++ b/vignettes/api/0/api-ccte.epa.gov/bioactivity/data/search/by-m4id/1842443.json @@ -0,0 +1,211 @@ +{ + "aeid": 704, + "m4id": 1842443, + "spid": "TP0000904H05", + "chid": 45232, + "casn": "51-24-1", + "chnm": "Tiratricol", + "dtxsid": "DTXSID2045232", + "bmad": 3.7634679299683276, + "respMax": 5.412234762165331, + "respMin": -10.497225111686998, + "maxMean": 5.412234762165331, + "maxMeanConc": -0.6989700043360187, + "maxMed": 5.412234762165331, + "maxMedConc": -0.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 42, + "m5id": 5037089, + "modl": "poly1", + "hitc": 1.3111515548405657E-6, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.7781512503836436, + 1.3010299956639813, + -0.6989700043360187, + -1.6989700043360187, + 1.6989700043360187, + -0.22184874961635637, + 0.3010299956639812, + -1.154901959985743 + ], + "resp": [ + -10.497225111686998, + -8.271301702212094, + 5.412234762165331, + -0.5697089223331855, + -5.4107315723966085, + -1.152645914630851, + -9.935332776150975, + 0.5697089223331855 + ] + }, + "mc4Param": { + "pow_a": 5.868021963410569E-8, + "pow_p": 0.31010469927487905, + "exp2_a": 0.00000820221770260021, + "exp2_b": 63.67412912081, + "exp3_a": 0.000015100154689265508, + "exp3_b": 66.7682650559194, + "exp3_p": 4.045012130124175, + "exp5_p": 2.5184566900851344, + "gnls_p": 1.004146220375644, + "gnls_q": 7.988324375445398, + "hill_p": 2.638717782813107, + "pow_er": 1.748991997794754, + "cnst_er": 1.749320687470586, + "exp2_er": 1.7502584913338175, + "exp3_er": 1.7494323994898786, + "exp4_er": 1.7493097643658628, + "exp4_ga": 3.3432891621411227, + "exp4_tp": 3.7125542218244536E-10, + "exp5_er": 1.7493111824172694, + "exp5_ga": 3.185722315810508, + "exp5_tp": 5.594093755272163E-10, + "gnls_er": 1.7165456563641568, + "gnls_ga": 0.015706640010627146, + "gnls_la": 0.4966875709539269, + "gnls_tp": 2.580846160887361, + "hill_er": 1.749345944481645, + "hill_ga": 33.73657111465509, + "hill_tp": 4.159714315410043E-9, + "poly1_a": 2.671599719093895E-11, + "poly2_a": 0.000005233244887677393, + "poly2_b": 60.3011801386689, + "pow_aic": 59.65799055310836, + "pow_cov": 1, + "pow_rme": 6.498682968118529, + "pow_top": 1.9740143842658864E-7, + "all_bmed": 0, + "cnst_aic": 55.65798921703397, + "cnst_rme": 6.498682892070479, + "exp2_aic": 59.65800315845096, + "exp2_cov": 1, + "exp2_rme": 6.4986846045958355, + "exp2_top": 0.000009784846486708034, + "exp3_aic": 61.657991223897305, + "exp3_cov": 1, + "exp3_rme": 6.4986834826679445, + "exp3_top": 0.00000549637162559571, + "exp4_aic": 59.65798921968127, + "exp4_cov": 1, + "exp4_rme": 6.498682892244033, + "exp4_top": 3.7125542218244536E-10, + "exp5_aic": 61.65798921951322, + "exp5_cov": 1, + "exp5_rme": 6.498682892347669, + "exp5_top": 5.594093755272163E-10, + "gnls_aic": 65.24298472190893, + "gnls_cov": 1, + "gnls_rme": 6.371147760432374, + "gnls_top": 2.422030692633518, + "hill_aic": 61.65798922272976, + "hill_cov": 1, + "hill_rme": 6.498682892532436, + "hill_top": 4.159714315410043E-9, + "poly1_er": 1.7493384697041403, + "poly2_er": 1.749869269967504, + "pow_a_sd": null, + "pow_ac50": 5.348516727471637, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 29.786661402010136, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 42.90853049989956, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 3.3432891621411227, + "exp5_ac50": 3.185722315810508, + "exp5_p_sd": null, + "gnls_ac50": 0.013892709273921892, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 33.73657111465509, + "hill_p_sd": null, + "poly1_aic": 57.65798921945516, + "poly1_cov": 1, + "poly1_rme": 6.49868289233687, + "poly1_top": 1.335799859546947E-9, + "poly2_aic": 59.65799619491047, + "poly2_cov": 1, + "poly2_rme": 6.498684235032681, + "poly2_top": 0.000007937241563467504, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.32379470628075435, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.40176401368837, + "poly2_b_sd": null, + "poly1_er_sd": 0.7320994661619505, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.5007494385640836 + }, + "mc5Param": { + "a": 2.671599719093895E-11, + "er": 1.7493384697041403, + "ac5": 2.4999999999999996, + "bmd": 347699605501.9814, + "bmr": 9.289141683881516, + "mll": -26.82899460972758, + "top": 1.335799859546947E-9, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 108.3553281419698, + "rmse": 6.49868289233687, + "ac1sd": 257746186435.86465, + "caikwt": 0.7310585788680222, + "hitcall": 0.0000013111515548405657, + "top_over_cutoff": 5.915642542126427E-11 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } +} diff --git a/vignettes/api/0/api-ccte.epa.gov/bioactivity/data/search/by-spid/TP0000904H05.json b/vignettes/api/0/api-ccte.epa.gov/bioactivity/data/search/by-spid/TP0000904H05.json new file mode 100644 index 00000000..64c6f26b --- /dev/null +++ b/vignettes/api/0/api-ccte.epa.gov/bioactivity/data/search/by-spid/TP0000904H05.json @@ -0,0 +1,1715 @@ +[ + { + "aeid": 623, + "m4id": 1833668, + "spid": "TP0000904H05", + "chid": 45232, + "casn": "51-24-1", + "chnm": "Tiratricol", + "dtxsid": "DTXSID2045232", + "bmad": 4.208854513532483, + "respMax": 29.901771956856702, + "respMin": -7.501926040061633, + "maxMean": 29.901771956856702, + "maxMeanConc": 1.3010299956639813, + "maxMed": 29.901771956856702, + "maxMedConc": 1.3010299956639813, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 2, + "tmpi": 173, + "m5id": 5028314, + "modl": "exp5", + "hitc": 0.3882324490933417, + "fitc": 15, + "coff": 25.253127081194897, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.6989700043360187, + -1.6989700043360187, + 1.3010299956639813, + 0.3010299956639812, + 0.7781512503836436, + -0.22184874961635637, + -1.154901959985743, + 1.6989700043360187 + ], + "resp": [ + 5.209938366718028, + -4.959553158705701, + 29.901771956856702, + -4.651386748844375, + -7.501926040061633, + -1.3578582434514619, + 4.9595531587057025, + 20.02118644067797 + ] + }, + "mc4Param": { + "pow_a": 0.44336623130581354, + "pow_p": 0.9925644596727824, + "exp2_a": 1721.5267035510278, + "exp2_b": 4025.7260629221983, + "exp3_a": 1149.7862297572626, + "exp3_b": 3865.930582986358, + "exp3_p": 0.917722768672351, + "exp5_p": 7.999998569591368, + "gnls_p": 7.999999998725721, + "gnls_q": 6.1299493285886815, + "hill_p": 7.999999995602079, + "pow_er": 1.9125454943910825, + "cnst_er": 2.2713874650689845, + "exp2_er": 1.9114072623315592, + "exp3_er": 1.9217973647521511, + "exp4_er": 1.941838889601473, + "exp4_ga": 13.263284766380592, + "exp4_tp": 24.09270151565037, + "exp5_er": 1.5919951761954754, + "exp5_ga": 14.42814252864356, + "exp5_tp": 24.957524183833613, + "gnls_er": 1.602022603368262, + "gnls_ga": 11.075019190563058, + "gnls_la": 4057.2571930089903, + "gnls_tp": 24.99533986136314, + "hill_er": 1.6020268977019103, + "hill_ga": 11.07620152627384, + "hill_tp": 24.995330944202244, + "poly1_a": 0.4304809360209948, + "poly2_a": 1481.0924717053826, + "poly2_b": 3489.637064916511, + "pow_aic": 63.54642686971948, + "pow_cov": 1, + "pow_rme": 9.110378433889926, + "pow_top": 21.532767773256374, + "all_bmed": 0, + "cnst_aic": 65.7380627468674, + "cnst_rme": 13.467830827162247, + "exp2_aic": 63.5509972646931, + "exp2_cov": 1, + "exp2_rme": 9.128808609267953, + "exp2_top": 21.514900150579237, + "exp3_aic": 65.56286926134463, + "exp3_cov": 1, + "exp3_rme": 9.029227555570293, + "exp3_top": 21.464382238767605, + "exp4_aic": 62.98697633687659, + "exp4_cov": 1, + "exp4_rme": 8.155246492992447, + "exp4_top": 24.09270151565037, + "exp5_aic": 58.33551786266656, + "exp5_cov": 1, + "exp5_rme": 5.064097391524118, + "exp5_top": 24.957524183833613, + "gnls_aic": 62.50680467218653, + "gnls_cov": 1, + "gnls_rme": 5.12230318637964, + "gnls_top": 24.995339798729216, + "hill_aic": 58.50680471790864, + "hill_cov": 1, + "hill_rme": 5.12229712088364, + "hill_top": 24.995330944202244, + "poly1_er": 1.9115526550839648, + "poly2_er": 1.9107008970876125, + "pow_a_sd": 1.30795225093553, + "pow_ac50": 24.870523119834353, + "pow_p_sd": 0.7451572698575011, + "all_onesd": 5.871582120667167, + "exp2_a_sd": 26000.97172895427, + "exp2_ac50": 25.077625249843255, + "exp2_b_sd": 60411.57063986761, + "exp3_a_sd": null, + "exp3_ac50": 23.61210508379751, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 13.263284766380592, + "exp5_ac50": 14.42814252864356, + "exp5_p_sd": 14.257258147825569, + "gnls_ac50": 11.075019183625043, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 11.07620152627384, + "hill_p_sd": 5.6132273415436185, + "poly1_aic": 61.5465618387384, + "poly1_cov": 1, + "poly1_rme": 9.121069696481047, + "poly1_top": 21.524046801049735, + "poly2_aic": 63.5566347758779, + "poly2_cov": 1, + "poly2_rme": 9.136999205494709, + "poly2_top": 21.52535837501469, + "pow_er_sd": 0.35032444517103617, + "exp2_er_sd": 0.33775432638513775, + "exp3_er_sd": null, + "exp4_er_sd": 0.31898399504554403, + "exp4_ga_sd": 16.437658831836973, + "exp4_tp_sd": 9.402421344167246, + "exp5_er_sd": 0.2866421065447428, + "exp5_ga_sd": 10.811848496418005, + "exp5_tp_sd": 4.504679302336407, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.2889737774748023, + "hill_ga_sd": 4.654460027967879, + "hill_tp_sd": 4.624285420174428, + "poly1_a_sd": 0.12591284476723125, + "poly1_ac50": 24.999999999999993, + "poly2_a_sd": 15244.347569196254, + "poly2_ac50": 25.176562967913593, + "poly2_b_sd": 35357.40607056334, + "poly1_er_sd": 0.3376542920341601, + "poly2_er_sd": 0.33789398129427817, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 4057.257196326073 + }, + "mc5Param": { + "p": 7.999998569591368, + "er": 1.5919951761954754, + "ga": 14.42814252864356, + "tp": 24.957524183833613, + "ac5": 10.419929728081096, + "bmd": 13.391740000924123, + "bmr": 7.920764280780008, + "mll": -25.16775893133328, + "top": 24.957524183833613, + "ac10": 11.400974094782285, + "ac20": 12.522189530406145, + "ac50": 14.42814252864356, + "bmdl": 6.346138919905622, + "bmdu": 16.86891434152304, + "rmse": 5.064097391524118, + "ac1sd": 12.813544894047944, + "caikwt": 0.024097080019334458, + "hitcall": 0.3882324490933417, + "top_over_cutoff": 0.9882944042371128 + }, + "mc6Param": { + "flag": [ + "Borderline", + "Average number of replicates per conc is less than 2", + "Multiple points above baseline, inactive" + ], + "mc6MthdId": [ + 11, + 13, + 8 + ] + } + }, + { + "aeid": 626, + "m4id": 1834094, + "spid": "TP0000904H05", + "chid": 45232, + "casn": "51-24-1", + "chnm": "Tiratricol", + "dtxsid": "DTXSID2045232", + "bmad": 4.884792210388105, + "respMax": 29.6569605105704, + "respMin": -0.8775428799361791, + "maxMean": 29.6569605105704, + "maxMeanConc": 1.3010299956639813, + "maxMed": 29.6569605105704, + "maxMedConc": 1.3010299956639813, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 2, + "tmpi": 127, + "m5id": 5028740, + "modl": "exp4", + "hitc": 0.01954693088289667, + "fitc": 13, + "coff": 29.30875326232863, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -1.154901959985743, + 1.6989700043360187, + 0.7781512503836436, + -0.22184874961635637, + -1.6989700043360187, + 1.3010299956639813, + 0.3010299956639812, + -0.6989700043360187 + ], + "resp": [ + -0.8775428799361791, + 14.818508177104107, + 7.818109293976865, + 0.6182688472277631, + 0.8775428799361791, + 29.6569605105704, + 14.000797766254488, + 11.22856003191065 + ] + }, + "mc4Param": { + "pow_a": 6.104769005070028, + "pow_p": 0.30000061702105263, + "exp2_a": 2626.4817742925065, + "exp2_b": 6939.1379984058385, + "exp3_a": 120.15711077915388, + "exp3_b": 23397.765294430603, + "exp3_p": 0.30000031698770585, + "exp5_p": 0.594894190079819, + "gnls_p": 0.8731492533237095, + "gnls_q": 7.968128567118133, + "hill_p": 0.699837429056946, + "pow_er": 1.7335248446140346, + "cnst_er": 2.380613185122028, + "exp2_er": 2.060944039839989, + "exp3_er": 1.8546380117175023, + "exp4_er": 1.742284415011934, + "exp4_ga": 2.8193975022647706, + "exp4_tp": 19.007523606809062, + "exp5_er": 1.6978383675225492, + "exp5_ga": 1.6927866800008955, + "exp5_tp": 18.11557823124747, + "gnls_er": 1.6327825441519803, + "gnls_ga": 1.735452996784926, + "gnls_la": 54.87984244327055, + "gnls_tp": 24.19390328229074, + "hill_er": 1.6938476048310585, + "hill_ga": 1.813379328743659, + "hill_tp": 19.44068645643118, + "poly1_a": 0.37984578052812146, + "poly2_a": 2264.1081940817717, + "poly2_b": 6022.235022571993, + "pow_aic": 60.00263716196596, + "pow_cov": 1, + "pow_rme": 6.885998407649498, + "pow_top": 19.740642572392304, + "all_bmed": 0, + "cnst_aic": 66.57834307933227, + "cnst_rme": 13.621084951805804, + "exp2_aic": 65.81071829753414, + "exp2_cov": 1, + "exp2_rme": 10.22892676304634, + "exp2_top": 18.99347662794126, + "exp3_aic": 62.2288005070792, + "exp3_cov": 1, + "exp3_rme": 6.886283476321515, + "exp3_top": 20.58121443270486, + "exp4_aic": 59.581830457686145, + "exp4_cov": 1, + "exp4_rme": 6.490262952004159, + "exp4_top": 19.007523606809062, + "exp5_aic": 60.930401394432195, + "exp5_cov": 1, + "exp5_rme": 6.304211108274938, + "exp5_top": 18.11557823124747, + "gnls_aic": 64.01083808276202, + "gnls_cov": 1, + "gnls_rme": 5.921058456285511, + "gnls_top": 22.158867072863508, + "hill_aic": 61.05594929038858, + "hill_cov": 1, + "hill_rme": 6.438553620903468, + "hill_top": 19.44068645643118, + "poly1_er": 2.059622051495357, + "poly2_er": 2.0605577889775617, + "pow_a_sd": 3.149959838854599, + "pow_ac50": 4.960651860666694, + "pow_p_sd": 0.1482676079125486, + "all_onesd": 7.091261826118074, + "exp2_a_sd": 30938.21312122273, + "exp2_ac50": 25.045034314642436, + "exp2_b_sd": 81312.38225224172, + "exp3_a_sd": 303.1118237953914, + "exp3_ac50": 5.644138602314242, + "exp3_b_sd": 141170.26637545082, + "exp3_p_sd": 0.17783524373196458, + "exp4_ac50": 2.8193975022647706, + "exp5_ac50": 1.6927866800008955, + "exp5_p_sd": 0.40135476309182777, + "gnls_ac50": 1.4306730373148124, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 1.813379328743659, + "hill_p_sd": 0.6752166489168941, + "poly1_aic": 63.80340730003342, + "poly1_cov": 1, + "poly1_rme": 10.22362919651012, + "poly1_top": 18.99228902640607, + "poly2_aic": 65.82009863445656, + "poly2_cov": 1, + "poly2_rme": 10.238688730082709, + "poly2_top": 18.953977151594913, + "pow_er_sd": 0.3335635504694223, + "exp2_er_sd": 0.34947041875452034, + "exp3_er_sd": 0.34371770733317997, + "exp4_er_sd": 0.3221439177850666, + "exp4_ga_sd": 4.969271064671941, + "exp4_tp_sd": 7.484672815601464, + "exp5_er_sd": 0.3208267776910146, + "exp5_ga_sd": 2.2579559312184383, + "exp5_tp_sd": 5.794590169915659, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": 0.32586972894861654, + "hill_ga_sd": 3.8056187634873897, + "hill_tp_sd": 9.540592027517304, + "poly1_a_sd": 0.160075249411384, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 17871.438263865843, + "poly2_ac50": 25.102925760278133, + "poly2_b_sd": 47059.40366080807, + "poly1_er_sd": 0.3493877366290281, + "poly2_er_sd": 0.3495083063258392, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 55.428544878921535 + }, + "mc5Param": { + "er": 1.742284415011934, + "ga": 2.8193975022647706, + "tp": 19.007523606809062, + "ac5": 0.2086370544887254, + "bmd": 2.8461708745717997, + "bmr": 9.56611220343328, + "mll": -26.790915228843073, + "top": 19.007523606809062, + "ac10": 0.4285571419954925, + "ac20": 0.9076432666342852, + "ac50": 2.8193975022647706, + "bmdl": 0.42381147732328206, + "bmdu": 10.478324051348984, + "rmse": 6.490262952004159, + "ac1sd": 1.899255719797609, + "caikwt": 0.029361884721225712, + "hitcall": 0.01954693088289667, + "top_over_cutoff": 0.6485271972056202 + }, + "mc6Param": { + "flag": [ + "Average number of replicates per conc is less than 2", + "Multiple points above baseline, inactive", + "Bmd > ac50, indication of high baseline variability" + ], + "mc6MthdId": [ + 13, + 8, + 9 + ] + } + }, + { + "aeid": 645, + "m4id": 1836233, + "spid": "TP0000904H05", + "chid": 45232, + "casn": "51-24-1", + "chnm": "Tiratricol", + "dtxsid": "DTXSID2045232", + "bmad": 3.4265572687763393, + "respMax": 7.386363636363637, + "respMin": -9.09090909090909, + "maxMean": 7.386363636363637, + "maxMeanConc": 1.6989700043360187, + "maxMed": 7.386363636363637, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 134, + "m5id": 5030879, + "modl": "poly1", + "hitc": 4.481617968402787E-5, + "fitc": 13, + "coff": 20.559343612658036, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.7781512503836436, + -1.6989700043360187, + -1.154901959985743, + -0.6989700043360187, + -0.22184874961635637, + 1.3010299956639813, + 0.3010299956639812, + 1.6989700043360187 + ], + "resp": [ + -7.702020202020201, + 2.904040404040405, + -2.904040404040403, + -0.9469696969696955, + -8.143939393939391, + -3.5984848484848477, + -9.09090909090909, + 7.386363636363637 + ] + }, + "mc4Param": { + "pow_a": 7.38792442803479E-8, + "pow_p": 4.707344288793977, + "exp2_a": 9.720535659483423E-7, + "exp2_b": 3.155293427742727, + "exp3_a": 10.992475308914631, + "exp3_b": 54.33735479981147, + "exp3_p": 7.997291932162272, + "exp5_p": 7.999998484010299, + "gnls_p": 7.999999892071809, + "gnls_q": 2.9607003309368434, + "hill_p": 7.9999961146922605, + "pow_er": 1.5635126278095273, + "cnst_er": 1.719984746193826, + "exp2_er": 1.5591089362306945, + "exp3_er": 1.559419875600755, + "exp4_er": 1.6883920413738989, + "exp4_ga": 74.80480041333628, + "exp4_tp": 8.863636346356905, + "exp5_er": 1.5607744582298897, + "exp5_ga": 44.417660789138985, + "exp5_tp": 8.863603105060312, + "gnls_er": 1.561195254781372, + "gnls_ga": 41.16217714273171, + "gnls_la": 1968.4261784520863, + "gnls_tp": 8.863620744215016, + "hill_er": 1.5615418348405026, + "hill_ga": 41.134292358351026, + "hill_tp": 8.85885765273257, + "poly1_a": 0.0916727261027705, + "poly2_a": 0.00003275646438816725, + "poly2_b": 0.11084829353336607, + "pow_aic": 56.802529668867656, + "pow_cov": 1, + "pow_rme": 5.474106464958057, + "pow_top": 7.347831543130136, + "all_bmed": 0, + "cnst_aic": 54.82949934043421, + "cnst_rme": 6.057646057469498, + "exp2_aic": 56.76807692440605, + "exp2_cov": 1, + "exp2_rme": 5.465880012590823, + "exp2_top": 7.407786706660837, + "exp3_aic": 58.76914315577856, + "exp3_cov": 1, + "exp3_rme": 5.466134248427126, + "exp3_top": 7.388890198629367, + "exp4_aic": 58.3862013644993, + "exp4_cov": 1, + "exp4_rme": 5.91931768956607, + "exp4_top": 8.863636346356905, + "exp5_aic": 58.771451215856445, + "exp5_cov": 1, + "exp5_rme": 5.466684000894818, + "exp5_top": 8.863603105060312, + "gnls_aic": 62.777644709625726, + "gnls_cov": 1, + "gnls_rme": 5.468147134258676, + "gnls_top": 8.859894820651965, + "hill_aic": 58.77767023528245, + "hill_cov": 1, + "hill_rme": 5.468153598929289, + "hill_top": 8.85885765273257, + "poly1_er": 1.6708188343034331, + "poly2_er": 1.603520396966836, + "pow_a_sd": 0.0000014804515060319311, + "pow_ac50": 43.15399398938185, + "pow_p_sd": 0.148714056473758, + "all_onesd": 9.788806432103662, + "exp2_a_sd": 0.00000229547866974318, + "exp2_ac50": 47.81291767075994, + "exp2_b_sd": 0.1144483227925822, + "exp3_a_sd": null, + "exp3_ac50": 46.540170334040354, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 74.80480041333628, + "exp5_ac50": 44.417660789138985, + "exp5_p_sd": 30.83791719208217, + "gnls_ac50": 41.157961075007606, + "gnls_p_sd": 20.623651182531617, + "gnls_q_sd": 917.2489266479544, + "hill_ac50": 41.134292358351026, + "hill_p_sd": 20.755167151874623, + "poly1_aic": 56.20208741239672, + "poly1_cov": 1, + "poly1_rme": 5.879174343453156, + "poly1_top": 4.5836363051385245, + "poly2_aic": 57.24725841856889, + "poly2_cov": 1, + "poly2_rme": 5.591373578271515, + "poly2_top": 6.679450797669966, + "pow_er_sd": 0.31476622758872136, + "exp2_er_sd": 0.31494236846040924, + "exp3_er_sd": null, + "exp4_er_sd": 0.3050999358871871, + "exp4_ga_sd": 206.23903994982948, + "exp4_tp_sd": 24.866384140473222, + "exp5_er_sd": 0.3151258300122656, + "exp5_ga_sd": 133.05442859689597, + "exp5_tp_sd": 82.18120992121477, + "gnls_er_sd": 0.31519605639597137, + "gnls_ga_sd": 64.74140517770995, + "gnls_la_sd": 2232417.631488272, + "gnls_tp_sd": 23.216264261253723, + "hill_er_sd": 0.3152310297032542, + "hill_ga_sd": 66.03127922964485, + "hill_tp_sd": 23.585311596930016, + "poly1_a_sd": 0.10105939936781418, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 0.000828471087305424, + "poly2_ac50": 35.339127399684344, + "poly2_b_sd": 1.4052316063819617, + "poly1_er_sd": 0.30563589696444254, + "poly2_er_sd": 0.31148611469958, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 1968.9852136355971 + }, + "mc5Param": { + "a": 0.0916727261027705, + "er": 1.6708188343034331, + "ac5": 2.5, + "bmd": 144.0461131493368, + "bmr": 13.20509987690784, + "mll": -26.10104370619836, + "top": 4.5836363051385245, + "ac10": 5, + "ac20": 10, + "ac50": 24.999999999999996, + "bmdl": 52.7459473602489, + "rmse": 5.879174343453156, + "ac1sd": 106.77992079268851, + "caikwt": 0.6651420101678049, + "hitcall": 0.00004481617968402787, + "top_over_cutoff": 0.22294662667715023 + }, + "mc6Param": { + "flag": [ + "Average number of replicates per conc is less than 2", + "Bmd > ac50, indication of high baseline variability" + ], + "mc6MthdId": [ + 13, + 9 + ] + } + }, + { + "aeid": 647, + "m4id": 1836494, + "spid": "TP0000904H05", + "chid": 45232, + "casn": "51-24-1", + "chnm": "Tiratricol", + "dtxsid": "DTXSID2045232", + "bmad": 2.8724632813460445, + "respMax": 24.5911214953271, + "respMin": -15.344176851186198, + "maxMean": 24.5911214953271, + "maxMeanConc": -0.6989700043360187, + "maxMed": 24.5911214953271, + "maxMedConc": -0.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 1, + "tmpi": 176, + "m5id": 5031140, + "modl": "poly1", + "hitc": 7.691234876598405E-4, + "fitc": 13, + "coff": 20.0, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.22184874961635637, + -1.154901959985743, + -1.6989700043360187, + 1.6989700043360187, + 0.3010299956639812, + -0.6989700043360187, + 1.3010299956639813, + 0.7781512503836436 + ], + "resp": [ + 0.31002875629043825, + -4.23705966930266, + 4.23705966930266, + -10.65330697340043, + -15.344176851186198, + 24.5911214953271, + -3.338425593098491, + 4.084291876347951 + ] + }, + "mc4Param": { + "pow_a": 0.0000015333586251507758, + "pow_p": 0.3766871063745604, + "exp2_a": 0.0000011936693923752977, + "exp2_b": 75.25835790295875, + "exp3_a": 0.0006569488939842799, + "exp3_b": 96.83528802743167, + "exp3_p": 7.800663857633126, + "exp5_p": 7.937542044894579, + "gnls_p": 0.729162061739079, + "gnls_q": 7.999999989113995, + "hill_p": 7.874824062203916, + "pow_er": 2.14936705216903, + "cnst_er": 2.149647244900154, + "exp2_er": 2.1499314425778753, + "exp3_er": 2.150315520704397, + "exp4_er": 2.149639800584959, + "exp4_ga": 19.434543462158643, + "exp4_tp": 1.1341713592504431E-9, + "exp5_er": 2.1496833837069445, + "exp5_ga": 116.5095827986136, + "exp5_tp": 0.0024033220782305803, + "gnls_er": 2.16232385103293, + "gnls_ga": 0.014951651893028646, + "gnls_la": 0.4728127504187675, + "gnls_tp": 11.2206197033088, + "hill_er": 2.1496462163421155, + "hill_ga": 158.06723237834862, + "hill_tp": 0.09087731268651236, + "poly1_a": 1.2510975773993083E-9, + "poly2_a": 0.000010622282859787738, + "poly2_b": 65.91494218290552, + "pow_aic": 67.2883088418402, + "pow_cov": 1, + "pow_rme": 11.277677799643604, + "pow_top": 0.000006693046390825522, + "all_bmed": 0, + "cnst_aic": 63.288305947678175, + "cnst_rme": 11.277676854033178, + "exp2_aic": 67.2883069898754, + "exp2_cov": 1, + "exp2_rme": 11.27767700055377, + "exp2_top": 0.0000011259662475929594, + "exp3_aic": 69.28831082872938, + "exp3_cov": 1, + "exp3_rme": 11.27767730254966, + "exp3_top": 0.000003797491381994292, + "exp4_aic": 67.28830594801778, + "exp4_cov": 1, + "exp4_rme": 11.277676854167195, + "exp4_top": 1.1341713592504431E-9, + "exp5_aic": 69.2883064884335, + "exp5_cov": 1, + "exp5_rme": 11.277677092560204, + "exp5_top": 0.0024033220782305803, + "gnls_aic": 72.17919094570237, + "gnls_cov": 1, + "gnls_rme": 9.771294007073369, + "gnls_top": 9.896104475278875, + "hill_aic": 69.28830869470625, + "hill_cov": 1, + "hill_rme": 11.277678096478796, + "hill_top": 0.09087731268651236, + "poly1_er": 2.1496851424365406, + "poly2_er": 2.1489661386583347, + "pow_a_sd": null, + "pow_ac50": 7.939966888042317, + "pow_p_sd": null, + "all_onesd": 10.104413980537656, + "exp2_a_sd": null, + "exp2_ac50": 29.078168746553875, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 45.7572447748528, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 19.434543462158643, + "exp5_ac50": 116.5095827986136, + "exp5_p_sd": null, + "gnls_ac50": 0.01079980647197256, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 158.06723237834862, + "hill_p_sd": null, + "poly1_aic": 65.28830598103433, + "poly1_cov": 1, + "poly1_rme": 11.2776768623634, + "poly1_top": 6.255487886996541E-8, + "poly2_aic": 67.28831401939081, + "poly2_cov": 1, + "poly2_rme": 11.277678682582888, + "poly2_top": 0.000014169663550936488, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.4105028884852779, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.16200653088329, + "poly2_b_sd": null, + "poly1_er_sd": 0.6280287466170111, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.47847525919124695 + }, + "mc5Param": { + "a": 1.2510975773993083E-9, + "er": 2.1496851424365406, + "ac5": 2.4999999999999996, + "bmd": 10895116980.467772, + "bmr": 13.6308544597453, + "mll": -30.644152990517163, + "top": 6.255487886996541E-8, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 86.00840841895133, + "rmse": 11.2776768623634, + "ac1sd": 8076439570.398645, + "caikwt": 0.7310585819091135, + "hitcall": 0.0007691234876598405, + "top_over_cutoff": 3.12774394349827E-9 + }, + "mc6Param": { + "flag": [ + "Average number of replicates per conc is less than 2", + "Bmd > ac50, indication of high baseline variability" + ], + "mc6MthdId": [ + 13, + 9 + ] + } + }, + { + "aeid": 679, + "m4id": 1839401, + "spid": "TP0000904H05", + "chid": 45232, + "casn": "51-24-1", + "chnm": "Tiratricol", + "dtxsid": "DTXSID2045232", + "bmad": 5.621579363521706, + "respMax": 14.08123821744849, + "respMin": -6.612486732252886, + "maxMean": 14.08123821744849, + "maxMeanConc": 0.3010299956639812, + "maxMed": 14.08123821744849, + "maxMedConc": 0.3010299956639812, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 133, + "m5id": 5034047, + "modl": "exp4", + "hitc": 3.7196432829375366E-15, + "fitc": 13, + "coff": 33.72947618113024, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -1.6989700043360187, + 0.3010299956639812, + -1.154901959985743, + 0.7781512503836436, + -0.22184874961635637, + -0.6989700043360187, + 1.3010299956639813, + 1.6989700043360187 + ], + "resp": [ + 2.2780919791518146, + 14.08123821744849, + -2.2780919791518137, + -6.612486732252886, + 10.679150230502348, + 13.089523628471415, + 4.467468276222602, + 6.318616035359553 + ] + }, + "mc4Param": { + "pow_a": 2.240045406368432, + "pow_p": 0.30000049943105944, + "exp2_a": 112.98083072982448, + "exp2_b": 865.8254929535174, + "exp3_a": 4.545028620685052, + "exp3_b": 65.7285988399926, + "exp3_p": 0.3000003150791311, + "exp5_p": 7.999999018346869, + "gnls_p": 0.300091098903469, + "gnls_q": 7.550849029707361, + "hill_p": 0.30000000017227746, + "pow_er": 1.9084326032965633, + "cnst_er": 2.050383693644464, + "exp2_er": 1.951409270215791, + "exp3_er": 1.9203767699862313, + "exp4_er": 1.6754549302442965, + "exp4_ga": 0.07329301415768419, + "exp4_tp": 7.710786101521187, + "exp5_er": 1.513226499207291, + "exp5_ga": 0.1453438995327829, + "exp5_tp": 8.610190191604286, + "gnls_er": 1.8470198467698633, + "gnls_ga": 0.29231631165137606, + "gnls_la": 59.66977501585602, + "gnls_tp": 9.655899171708228, + "hill_er": 1.882783861146438, + "hill_ga": 54.87345686534822, + "hill_tp": 16.841921803354463, + "poly1_a": 0.13427234808054894, + "poly2_a": 163.94604679311635, + "poly2_b": 1270.0524640798787, + "pow_aic": 62.22501034060233, + "pow_cov": 1, + "pow_rme": 7.635077607201984, + "pow_top": 7.243503453530403, + "all_bmed": 0, + "cnst_aic": 60.31637953410401, + "cnst_rme": 8.643268453824428, + "exp2_aic": 63.20845198455855, + "exp2_cov": 1, + "exp2_rme": 8.236056037957985, + "exp2_top": 6.716525076559469, + "exp3_aic": 64.52332339400041, + "exp3_cov": 1, + "exp3_rme": 7.810212289193087, + "exp3_top": 6.873721691967609, + "exp4_aic": 59.07676009097395, + "exp4_cov": 1, + "exp4_rme": 6.585985949819935, + "exp4_top": 7.710786101521187, + "exp5_aic": 59.34963698633271, + "exp5_cov": 1, + "exp5_rme": 6.313571586200532, + "exp5_top": 8.610190191604286, + "gnls_aic": 66.68700367035977, + "gnls_cov": 1, + "gnls_rme": 7.005486126644505, + "gnls_top": 7.69073998343443, + "hill_aic": 63.70370651182299, + "hill_cov": 1, + "hill_rme": 7.371748953581798, + "hill_top": 16.841921803354463, + "poly1_er": 1.9514160891689865, + "poly2_er": 1.953269884448892, + "pow_a_sd": null, + "pow_ac50": 4.960647368144271, + "pow_p_sd": null, + "all_onesd": 9.193701942255004, + "exp2_a_sd": 2618.1000472689234, + "exp2_ac50": 25.360877092869007, + "exp2_b_sd": 19534.177463369564, + "exp3_a_sd": null, + "exp3_ac50": 9.693473276544648, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 0.07329301415768419, + "exp5_ac50": 0.1453438995327829, + "exp5_p_sd": 21.257608326450363, + "gnls_ac50": 0.07386566609090593, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 54.87345686534822, + "hill_p_sd": null, + "poly1_aic": 61.20659443782829, + "poly1_cov": 1, + "poly1_rme": 8.235017480262172, + "poly1_top": 6.713617404027446, + "poly2_aic": 63.209083993314835, + "poly2_cov": 1, + "poly2_rme": 8.236417282123691, + "poly2_top": 6.708398029005737, + "pow_er_sd": null, + "exp2_er_sd": 0.32176579624163837, + "exp3_er_sd": null, + "exp4_er_sd": 0.32290193845118853, + "exp4_ga_sd": 0.07925814316759382, + "exp4_tp_sd": 2.776801163350604, + "exp5_er_sd": 0.3377590868121545, + "exp5_ga_sd": 0.14972218569452714, + "exp5_tp_sd": 2.4071558977199987, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.11707993441117576, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 3437.347970091856, + "poly2_ac50": 25.473296332973103, + "poly2_b_sd": 25758.50715822951, + "poly1_er_sd": 0.32179810050301344, + "poly2_er_sd": 0.32190869935481625, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 60.347790496302295 + }, + "mc5Param": { + "er": 1.6754549302442965, + "ga": 0.07329301415768419, + "tp": 7.710786101521187, + "ac5": 0.005423725663435604, + "bmr": 12.402303920102002, + "mll": -26.538380045486974, + "top": 7.710786101521187, + "ac10": 0.01114076487987984, + "ac20": 0.023595080416335745, + "ac50": 0.07329301415768419, + "rmse": 6.585985949819935, + "caikwt": 0.34982472852238994, + "hitcall": 3.7196432829375366E-15, + "top_over_cutoff": 0.22860675511572107 + }, + "mc6Param": { + "flag": [ + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 13 + ] + } + }, + { + "aeid": 704, + "m4id": 1842443, + "spid": "TP0000904H05", + "chid": 45232, + "casn": "51-24-1", + "chnm": "Tiratricol", + "dtxsid": "DTXSID2045232", + "bmad": 3.7634679299683276, + "respMax": 5.412234762165331, + "respMin": -10.497225111686998, + "maxMean": 5.412234762165331, + "maxMeanConc": -0.6989700043360187, + "maxMed": 5.412234762165331, + "maxMedConc": -0.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 0, + "tmpi": 42, + "m5id": 5037089, + "modl": "poly1", + "hitc": 1.3111515548405657E-6, + "fitc": 13, + "coff": 22.580807579809964, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 0.7781512503836436, + 1.3010299956639813, + -0.6989700043360187, + -1.6989700043360187, + 1.6989700043360187, + -0.22184874961635637, + 0.3010299956639812, + -1.154901959985743 + ], + "resp": [ + -10.497225111686998, + -8.271301702212094, + 5.412234762165331, + -0.5697089223331855, + -5.4107315723966085, + -1.152645914630851, + -9.935332776150975, + 0.5697089223331855 + ] + }, + "mc4Param": { + "pow_a": 5.868021963410569E-8, + "pow_p": 0.31010469927487905, + "exp2_a": 0.00000820221770260021, + "exp2_b": 63.67412912081, + "exp3_a": 0.000015100154689265508, + "exp3_b": 66.7682650559194, + "exp3_p": 4.045012130124175, + "exp5_p": 2.5184566900851344, + "gnls_p": 1.004146220375644, + "gnls_q": 7.988324375445398, + "hill_p": 2.638717782813107, + "pow_er": 1.748991997794754, + "cnst_er": 1.749320687470586, + "exp2_er": 1.7502584913338175, + "exp3_er": 1.7494323994898786, + "exp4_er": 1.7493097643658628, + "exp4_ga": 3.3432891621411227, + "exp4_tp": 3.7125542218244536E-10, + "exp5_er": 1.7493111824172694, + "exp5_ga": 3.185722315810508, + "exp5_tp": 5.594093755272163E-10, + "gnls_er": 1.7165456563641568, + "gnls_ga": 0.015706640010627146, + "gnls_la": 0.4966875709539269, + "gnls_tp": 2.580846160887361, + "hill_er": 1.749345944481645, + "hill_ga": 33.73657111465509, + "hill_tp": 4.159714315410043E-9, + "poly1_a": 2.671599719093895E-11, + "poly2_a": 0.000005233244887677393, + "poly2_b": 60.3011801386689, + "pow_aic": 59.65799055310836, + "pow_cov": 1, + "pow_rme": 6.498682968118529, + "pow_top": 1.9740143842658864E-7, + "all_bmed": 0, + "cnst_aic": 55.65798921703397, + "cnst_rme": 6.498682892070479, + "exp2_aic": 59.65800315845096, + "exp2_cov": 1, + "exp2_rme": 6.4986846045958355, + "exp2_top": 0.000009784846486708034, + "exp3_aic": 61.657991223897305, + "exp3_cov": 1, + "exp3_rme": 6.4986834826679445, + "exp3_top": 0.00000549637162559571, + "exp4_aic": 59.65798921968127, + "exp4_cov": 1, + "exp4_rme": 6.498682892244033, + "exp4_top": 3.7125542218244536E-10, + "exp5_aic": 61.65798921951322, + "exp5_cov": 1, + "exp5_rme": 6.498682892347669, + "exp5_top": 5.594093755272163E-10, + "gnls_aic": 65.24298472190893, + "gnls_cov": 1, + "gnls_rme": 6.371147760432374, + "gnls_top": 2.422030692633518, + "hill_aic": 61.65798922272976, + "hill_cov": 1, + "hill_rme": 6.498682892532436, + "hill_top": 4.159714315410043E-9, + "poly1_er": 1.7493384697041403, + "poly2_er": 1.749869269967504, + "pow_a_sd": null, + "pow_ac50": 5.348516727471637, + "pow_p_sd": null, + "all_onesd": 6.885946392795786, + "exp2_a_sd": null, + "exp2_ac50": 29.786661402010136, + "exp2_b_sd": null, + "exp3_a_sd": null, + "exp3_ac50": 42.90853049989956, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 3.3432891621411227, + "exp5_ac50": 3.185722315810508, + "exp5_p_sd": null, + "gnls_ac50": 0.013892709273921892, + "gnls_p_sd": null, + "gnls_q_sd": null, + "hill_ac50": 33.73657111465509, + "hill_p_sd": null, + "poly1_aic": 57.65798921945516, + "poly1_cov": 1, + "poly1_rme": 6.49868289233687, + "poly1_top": 1.335799859546947E-9, + "poly2_aic": 59.65799619491047, + "poly2_cov": 1, + "poly2_rme": 6.498684235032681, + "poly2_top": 0.000007937241563467504, + "pow_er_sd": null, + "exp2_er_sd": null, + "exp3_er_sd": null, + "exp4_er_sd": null, + "exp4_ga_sd": null, + "exp4_tp_sd": null, + "exp5_er_sd": null, + "exp5_ga_sd": null, + "exp5_tp_sd": null, + "gnls_er_sd": null, + "gnls_ga_sd": null, + "gnls_la_sd": null, + "gnls_tp_sd": null, + "hill_er_sd": null, + "hill_ga_sd": null, + "hill_tp_sd": null, + "poly1_a_sd": 0.32379470628075435, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": null, + "poly2_ac50": 30.40176401368837, + "poly2_b_sd": null, + "poly1_er_sd": 0.7320994661619505, + "poly2_er_sd": null, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 0.5007494385640836 + }, + "mc5Param": { + "a": 2.671599719093895E-11, + "er": 1.7493384697041403, + "ac5": 2.4999999999999996, + "bmd": 347699605501.9814, + "bmr": 9.289141683881516, + "mll": -26.82899460972758, + "top": 1.335799859546947E-9, + "ac10": 4.999999999999999, + "ac20": 9.999999999999998, + "ac50": 24.999999999999996, + "bmdl": 108.3553281419698, + "rmse": 6.49868289233687, + "ac1sd": 257746186435.86465, + "caikwt": 0.7310585788680222, + "hitcall": 0.0000013111515548405657, + "top_over_cutoff": 5.915642542126427E-11 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability", + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 9, + 13 + ] + } + }, + { + "aeid": 714, + "m4id": 1847540, + "spid": "TP0000904H05", + "chid": 45232, + "casn": "51-24-1", + "chnm": "Tiratricol", + "dtxsid": "DTXSID2045232", + "bmad": 4.065604241325404, + "respMax": 90.80446870746331, + "respMin": -5.707883228590463, + "maxMean": 90.62049611334439, + "maxMeanConc": 1.6989700043360187, + "maxMed": 90.62049611334439, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 16, + "nrep": 2.0, + "nmedGtbl": 6, + "tmpi": 1280, + "m5id": 5042186, + "modl": "hill", + "hitc": 0.9999999999990554, + "fitc": 42, + "coff": 24.393625447952424, + "actp": null, + "modelType": 2, + "chidRep": 1, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + -0.22184874961635637, + -0.6989700043360187, + 0.7781512503836436, + 0.3010299956639812, + -0.22184874961635637, + -0.6989700043360187, + -1.154901959985743, + 1.3010299956639813, + 0.7781512503836436, + 1.3010299956639813, + 0.3010299956639812, + -1.154901959985743, + -1.6989700043360187, + 1.6989700043360187, + -1.6989700043360187, + 1.6989700043360187 + ], + "resp": [ + 23.65294390222711, + 14.242737988357604, + 72.43005879116106, + 46.484959502640294, + 55.886726620789105, + 28.84492825461404, + 5.707883228590464, + 88.63403737583766, + 80.03489098177559, + 80.0297093264599, + 74.69438203693808, + 3.5586226430884302, + -5.707883228590463, + 90.80446870746331, + -3.5586226430884302, + 90.43652351922545 + ] + }, + "mc4Param": { + "pow_a": 32.911138431472224, + "pow_p": 0.3000000797458051, + "exp2_a": 10308.09931192428, + "exp2_b": 4751.077023800089, + "exp3_a": 1269.4299811454289, + "exp3_b": 214861.03156835592, + "exp3_p": 0.30000013149029114, + "exp5_p": 0.7104729913327161, + "gnls_p": 0.955542591689892, + "gnls_q": 7.509065539947891, + "hill_p": 0.9555341491157984, + "pow_er": 2.641957951988852, + "cnst_er": 3.95904849507247, + "exp2_er": 3.4960111520069024, + "exp3_er": 2.6880458922007326, + "exp4_er": 2.098857080265625, + "exp4_ga": 0.7897221222126788, + "exp4_tp": 83.97402405983311, + "exp5_er": 1.9948049077180752, + "exp5_ga": 1.2342906618623586, + "exp5_tp": 87.8897045568669, + "gnls_er": 1.9847399896737128, + "gnls_ga": 1.0031443070703985, + "gnls_la": 557.0432143919979, + "gnls_tp": 91.01391582017716, + "hill_er": 1.9847477692501443, + "hill_ga": 1.003191124397109, + "hill_tp": 91.01447500018872, + "poly1_a": 2.1865425331680353, + "poly2_a": 14664.260556155692, + "poly2_b": 6767.106371403012, + "pow_aic": 141.82653772826615, + "pow_cov": 1, + "pow_rme": 16.068716512669607, + "pow_top": 106.42264340458804, + "all_bmed": 0, + "cnst_aic": 179.848625362541, + "cnst_rme": 58.56882891622411, + "exp2_aic": 169.61132698024198, + "exp2_cov": 1, + "exp2_rme": 38.21336628800247, + "exp2_top": 109.05454587381912, + "exp3_aic": 144.43145465266923, + "exp3_cov": 0, + "exp3_rme": 16.37845865253221, + "exp3_top": 107.50377103361215, + "exp4_aic": 126.23812256465268, + "exp4_cov": 1, + "exp4_rme": 10.334639998161537, + "exp4_top": 83.97402405983311, + "exp5_aic": 125.99404191588884, + "exp5_cov": 1, + "exp5_rme": 10.04248749715944, + "exp5_top": 87.8897045568669, + "gnls_aic": 128.4085145582657, + "gnls_cov": 1, + "gnls_rme": 9.09129189490256, + "gnls_top": 90.40700949566956, + "hill_aic": 124.40851436294564, + "hill_cov": 1, + "hill_rme": 9.09135696458556, + "hill_top": 91.01447500018872, + "poly1_er": 3.4963072277205045, + "poly2_er": 3.4967033306110524, + "pow_a_sd": 5.539590328742932, + "pow_ac50": 4.960631334085256, + "pow_p_sd": 0.05065285664483593, + "all_onesd": 36.16048671325037, + "exp2_a_sd": 58049.23115375191, + "exp2_ac50": 25.065774256310934, + "exp2_b_sd": 26637.78941676024, + "exp3_a_sd": null, + "exp3_ac50": 5.304622230963994, + "exp3_b_sd": null, + "exp3_p_sd": null, + "exp4_ac50": 0.7897221222126788, + "exp5_ac50": 1.2342906618623586, + "exp5_p_sd": 0.11448338011960948, + "gnls_ac50": 0.9892404145079376, + "gnls_p_sd": 0.19605463854823008, + "gnls_q_sd": 4028.2837050226367, + "hill_ac50": 1.003191124397109, + "hill_p_sd": 0.1960536175489813, + "poly1_aic": 167.57928052693967, + "poly1_cov": 1, + "poly1_rme": 38.170211145924405, + "poly1_top": 109.32712665840177, + "poly2_aic": 169.62385203407865, + "poly2_cov": 1, + "poly2_rme": 38.225046010433935, + "poly2_top": 109.15012495603122, + "pow_er_sd": 0.22682743340833847, + "exp2_er_sd": 0.22434251903225583, + "exp3_er_sd": null, + "exp4_er_sd": 0.23345662340053935, + "exp4_ga_sd": 0.2852253940608193, + "exp4_tp_sd": 3.843251237417471, + "exp5_er_sd": 0.26681973494160827, + "exp5_ga_sd": 0.3934957270117465, + "exp5_tp_sd": 4.10415190766761, + "gnls_er_sd": 0.2447595646202884, + "gnls_ga_sd": 0.4933082047260317, + "gnls_la_sd": 720123.8796452188, + "gnls_tp_sd": 6.100726679795194, + "hill_er_sd": 0.24476191439739545, + "hill_ga_sd": 0.49331894680155614, + "hill_tp_sd": 6.10085139691297, + "poly1_a_sd": 0.45742366357273334, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 70563.77452581785, + "poly2_ac50": 25.091679894774504, + "poly2_b_sd": 32307.63616776071, + "poly1_er_sd": 0.22427708068428584, + "poly2_er_sd": 0.22436205738666837, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 557.6818189423375 + }, + "mc5Param": { + "p": 0.9555341491157984, + "er": 1.9847477692501443, + "ga": 1.003191124397109, + "tp": 91.01447500018872, + "ac5": 0.04603871449945376, + "acc": 0.3505460195302733, + "bmd": 1.1664879741712382, + "bmr": 48.78049657617475, + "mll": -58.20425718147282, + "top": 91.01447500018872, + "ac10": 0.1006318431871514, + "ac20": 0.23512931816587768, + "ac50": 1.003191124397109, + "bmdl": 0.7135391211625854, + "bmdu": 1.7796567328157402, + "rmse": 9.09135696458556, + "ac1sd": 0.6486166660027173, + "caikwt": 9.148141181839124E-13, + "hitcall": 0.9999999999990554, + "top_over_cutoff": 3.7310761860463177 + }, + "mc6Param": { + "flag": [ + "Bmd > ac50, indication of high baseline variability" + ], + "mc6MthdId": [ + 9 + ] + } + }, + { + "aeid": 719, + "m4id": 1850045, + "spid": "TP0000904H05", + "chid": 45232, + "casn": "51-24-1", + "chnm": "Tiratricol", + "dtxsid": "DTXSID2045232", + "bmad": 4.036116152450091, + "respMax": 107.21526582248697, + "respMin": -2.7450872741675525, + "maxMean": 107.21526582248697, + "maxMeanConc": 1.6989700043360187, + "maxMed": 107.21526582248697, + "maxMedConc": 1.6989700043360187, + "logcMax": 1.6989700043360187, + "logcMin": -1.6989700043360187, + "nconc": 8, + "npts": 8, + "nrep": 1.0, + "nmedGtbl": 5, + "tmpi": 907, + "m5id": 5044691, + "modl": "hill", + "hitc": 0.9999985006475061, + "fitc": 42, + "coff": 24.21669691470054, + "actp": null, + "modelType": 2, + "chidRep": 0, + "stkc": 20.0, + "stkcUnit": "mM", + "testedConcUnit": "uM", + "mc3Param": { + "logc": [ + 1.6989700043360187, + -0.22184874961635637, + 0.3010299956639812, + -1.6989700043360187, + 0.7781512503836436, + 1.3010299956639813, + -0.6989700043360187, + -1.154901959985743 + ], + "resp": [ + 107.21526582248697, + 30.195960015843077, + 23.92147481774581, + -2.7450872741675525, + 70.82325167352285, + 87.60749957843302, + 6.666640522978341, + 2.745087274167552 + ] + }, + "mc4Param": { + "pow_a": 26.38188579595087, + "pow_p": 0.373321688144596, + "exp2_a": 10555.066230255175, + "exp2_b": 4397.549085127513, + "exp3_a": 784.0385960885498, + "exp3_b": 12122.72093512508, + "exp3_p": 0.3638067662358064, + "exp5_p": 0.6706734088210354, + "gnls_p": 0.7940478448675982, + "gnls_q": 4.635795527795299, + "hill_p": 0.7940457988465808, + "pow_er": 2.233770712846338, + "cnst_er": 3.823652826194619, + "exp2_er": 3.112037332406609, + "exp3_er": 2.2207623331779267, + "exp4_er": 1.9257018004052453, + "exp4_ga": 3.8261863681864567, + "exp4_tp": 101.17371650605573, + "exp5_er": 1.851583883281417, + "exp5_ga": 4.388513514529561, + "exp5_tp": 108.53396863931586, + "gnls_er": 1.763196258086566, + "gnls_ga": 5.230735872271651, + "gnls_la": 3728.9702818099768, + "gnls_tp": 123.23260400266716, + "hill_er": 1.7632048386470296, + "hill_ga": 5.230720817485771, + "hill_tp": 123.23247985508776, + "poly1_a": 2.4157216564524493, + "poly2_a": 14475.570423248031, + "poly2_b": 6050.547391426295, + "pow_aic": 66.99572995533279, + "pow_cov": 1, + "pow_rme": 10.165270166462872, + "pow_top": 113.64967185920248, + "all_bmed": 0, + "cnst_aic": 89.66837566455231, + "cnst_rme": 56.71162606585343, + "exp2_aic": 82.18838027457493, + "exp2_cov": 1, + "exp2_rme": 27.76912571036805, + "exp2_top": 120.69563618612736, + "exp3_aic": 69.31400616583988, + "exp3_cov": 1, + "exp3_rme": 10.392779268529251, + "exp3_top": 113.91588681399294, + "exp4_aic": 63.470739630590785, + "exp4_cov": 1, + "exp4_rme": 8.85897961514353, + "exp4_top": 101.17371650605573, + "exp5_aic": 63.473426195943134, + "exp5_cov": 1, + "exp5_rme": 7.367611470284465, + "exp5_top": 108.53396863931586, + "gnls_aic": 66.84742309100423, + "gnls_cov": 1, + "gnls_rme": 7.41641546707749, + "gnls_top": 121.09148833061737, + "hill_aic": 62.84742306797685, + "hill_cov": 1, + "hill_rme": 7.41641875777227, + "hill_top": 123.23247985508776, + "poly1_er": 3.1106053488018537, + "poly2_er": 3.114821770788662, + "pow_a_sd": 5.3252399545122096, + "pow_ac50": 7.809343150454362, + "pow_p_sd": 0.056051948310051315, + "all_onesd": 11.631725174057522, + "exp2_a_sd": 62396.56299440558, + "exp2_ac50": 25.07106192806109, + "exp2_b_sd": 25839.769114659568, + "exp3_a_sd": 1271.834084672146, + "exp3_ac50": 8.152864786253309, + "exp3_b_sd": 47172.61248160081, + "exp3_p_sd": 0.060040388923249574, + "exp4_ac50": 3.8261863681864567, + "exp5_ac50": 4.388513514529561, + "exp5_p_sd": 0.1399475195939742, + "gnls_ac50": 5.006742473448925, + "gnls_p_sd": 0.1854347139300874, + "gnls_q_sd": 6795.493494626446, + "hill_ac50": 5.230720817485771, + "hill_p_sd": 0.1854307163440282, + "poly1_aic": 80.15930580117441, + "poly1_cov": 1, + "poly1_rme": 27.713999426199813, + "poly1_top": 120.78608282262245, + "poly2_aic": 82.20131097823085, + "poly2_cov": 1, + "poly2_rme": 27.795630326649007, + "poly2_top": 120.61051231658656, + "pow_er_sd": 0.2974052783401845, + "exp2_er_sd": 0.33465921260039705, + "exp3_er_sd": 0.29489066888069415, + "exp4_er_sd": 0.3357623948715002, + "exp4_ga_sd": 0.8745068218026666, + "exp4_tp_sd": 7.947871781710462, + "exp5_er_sd": 0.3159497283524588, + "exp5_ga_sd": 1.9622995568669583, + "exp5_tp_sd": 10.681406923273569, + "gnls_er_sd": 0.3405846164664119, + "gnls_ga_sd": 3.020438938884526, + "gnls_la_sd": 23405695.431429833, + "gnls_tp_sd": 17.604579650183712, + "hill_er_sd": 0.34058479447409523, + "hill_ga_sd": 3.020385246373638, + "hill_tp_sd": 17.60426841589827, + "poly1_a_sd": 0.46291777018798136, + "poly1_ac50": 24.999999999999996, + "poly2_a_sd": 72067.05274661083, + "poly2_ac50": 25.102448102487468, + "poly2_b_sd": 29880.417835129876, + "poly1_er_sd": 0.33437412905907915, + "poly2_er_sd": 0.33496016443302623, + "pow_success": 1, + "cnst_success": 1, + "exp2_success": 1, + "exp3_success": 1, + "exp4_success": 1, + "exp5_success": 1, + "gnls_success": 1, + "hill_success": 1, + "poly1_success": 1, + "poly2_success": 1, + "gnls_ac50_loss": 3748.429832774264 + }, + "mc5Param": { + "p": 0.7940457988465808, + "er": 1.7632048386470296, + "ga": 5.230720817485771, + "tp": 123.23247985508776, + "ac5": 0.1282724896705554, + "acc": 0.887855091317106, + "bmd": 0.46326275977400544, + "bmr": 15.691197259803596, + "mll": -27.423711533988424, + "top": 123.23247985508776, + "ac10": 0.3287108931871063, + "ac20": 0.9127320943550252, + "ac50": 5.230720817485771, + "bmdl": 0.33623832625756866, + "bmdu": 0.651275873448465, + "rmse": 7.41641875777227, + "ac1sd": 0.3032690510690583, + "caikwt": 0.0000014993516184967038, + "hitcall": 0.999998500647506, + "top_over_cutoff": 5.088740231136994 + }, + "mc6Param": { + "flag": [ + "Average number of replicates per conc is less than 2" + ], + "mc6MthdId": [ + 13 + ] + } + } +] diff --git a/vignettes/img/API_plot_1847540.jpg b/vignettes/img/API_plot_1847540.jpg new file mode 100644 index 00000000..34da45b5 Binary files /dev/null and b/vignettes/img/API_plot_1847540.jpg differ diff --git a/vignettes/img/API_plot_704.png b/vignettes/img/API_plot_704.png new file mode 100644 index 00000000..1c65367f Binary files /dev/null and b/vignettes/img/API_plot_704.png differ diff --git a/vignettes/img/API_plot_compare.png b/vignettes/img/API_plot_compare.png new file mode 100644 index 00000000..c170792a Binary files /dev/null and b/vignettes/img/API_plot_compare.png differ diff --git a/vignettes/img/API_plot_standalone.png b/vignettes/img/API_plot_standalone.png new file mode 100644 index 00000000..9f919f20 Binary files /dev/null and b/vignettes/img/API_plot_standalone.png differ