Overview

The NCI-60 cancer cell line panel has been used over the course of several decades as an anti-cancer drug screen. This panel was developed as part of the Developmental Therapeutics Program (DTP, http://dtp.nci.nih.gov/) of the U.S. National Cancer Institute (NCI). Thousands of compounds have been tested on the NCI-60, which have been extensively characterized by many platforms for gene and protein expression, copy number, mutation, and others (Reinhold, et al., 2012). The purpose of the CellMiner project (http://discover.nci.nih.gov/cellminer) has been to integrate data from multiple platforms used to analyze the NCI-60 and to provide a powerful suite of tools for exploration of NCI-60 data.

Basics

Installation

source("http://bioconductor.org/biocLite.R")
biocLite("rcellminer")
biocLite("rcellminerData")

Getting Started

Load rcellminer and rcellminerData packages:

library(rcellminer)
library(rcellminerData)

A list of all accessible vignettes and methods is available with the following command.

help.search("rcellminer")

Data Visualization

rcellminer provides several methods for the visualization of CellMiner data. The package provides methods to

Drug Visualization

Because the values of within rcellminer have been z-score transformed this allows different data within the package to be compared. Often, it is useful for researchers to visualize multiple data profiles next to each other in order to visually identify patterns. Below are examples for the visualization of various profiles: single drugs and multiple drugs, as well as, molecular profiles and combinations of drug and molecular profiles.

# Get Cellminer data
drugAct <- exprs(getAct(rcellminerData::drugData))
molData <- getMolDataMatrices()

# Two drugs 
nsc <- c("3284", "739")
plots <- c("drug", "drug") 
plotCellMiner(drugAct, molData, plots, nsc, NULL)

# Just drug
nsc <- "94600"
plots <- c("drug") 
plotCellMiner(drugAct, molData, plots, nsc, NULL)

# Just expression
gene <- "TP53"
plots <- c("exp") 
plotCellMiner(drugAct, molData, plots, NULL, gene)

# Two genes 
# NOTE: subscript out of bounds Errors likely mean the gene is not present for that data type
gene <- c("TP53", "MDM2")
plots <- c("exp", "mut", "exp") 
plotCellMiner(drugAct, molData, plots, NULL, gene)

# Gene and drug to plot 
nsc <- "94600"
gene <- "TP53"
plots <- c("mut", "drug", "cop") 
plotCellMiner(drugAct, molData, plots, nsc, gene)

Visualizing Drug Sets

For similar drugs, it is often useful to visualize the set of drugs collectively. rcellminer allows you to plot the average of the z-scores for a set of drugs quickly and with 1 standard deviation bars.

# Get CellMiner data
drugAct <- exprs(getAct(rcellminerData::drugData))

# Select drugs using NSC IDs
drugs <- "26273 39367 39368 105546 120958 255523 284751 289900 736740 743891 752330"

drugs <- strsplit(drugs, " ")[[1]]
drugAct <- drugAct[drugs,]
mainLabel <- paste("Drug Set: 1, Drugs:", length(drugs), sep=" ")

plotDrugSets(drugAct, drugs, mainLabel) 

Structure Visualization

The structures of the CellMiner compounds are visualized using the plotStructuresFromNscs method. This is a basic method that is a wrapper for functionality in the rcdk package. The first parameter is a user-defined string that will serve as a label for the compound, and the second parameter is a SMILES string for the componud of interest. Here we use the getSmiles method to retrieve the SMILES string for topotecan, a well-known topoisomerase inhibitor.

plotStructuresFromNscs("Topotecan", getSmiles("609699"))

Finding Similar Compounds

Generate drug set

Generate a set of drugs to be pairwise compared. Here we will compare a set of 100 compounds to a drug of interest MK2206 (an AKT inhibitor). We provide a name “MK2206” and the SMILES-based structure retrieved from PubChem.

# Load sqldf
library(sqldf)

# Set up necessary data
## Compound annotations
df <- as(featureData(getAct(rcellminerData::drugData)), "data.frame")
## Drug activities 
drugAct <- exprs(getAct(rcellminerData::drugData))
## Molecular profiling data
molData <- getMolDataMatrices() 

# Example filter on particular properties of the compounds
tmpDf <- sqldf("SELECT NSC, SMILES 
                             FROM df 
                             WHERE SMILES != ''")

# Compare against the 100 NSCs for demonstration
ids <- head(tmpDf$NSC, 100)
smiles <- head(tmpDf$SMILES, 100)

# All public
#ids <- tmpDf$nsc
#smiles <- tmpDf$smiles

drugOfInterest <- "MK2206"
smilesOfInterest <- "C1CC(C1)(C2=CC=C(C=C2)C3=C(C=C4C(=N3)C=CN5C4=NNC5=O)C6=CC=CC=C6)N"

# Make a vector of all the compounds to be pairwise compared 
ids <- c(drugOfInterest, ids)
smiles <- c(smilesOfInterest, smiles)

Run the comparison

# Run fingerprint comparison 
results <- compareFingerprints(ids, smiles)

Visualize structures

View the similar structures. The first drug in the results will be the drug of interest and the subsequent drugs will compounds related by structure in decreasing similarity.

NOTE: All compounds in CellMiner are uniquely identified by NSC identifiers.

# Plot top 2 results 
resultsIdx <- sapply(names(results)[2:3], function(x) { which(tmpDf$NSC == x) })
resultsIds <- names(results)[2:3]
resultsSmiles <- tmpDf$SMILES[resultsIdx]

resultsIds <- c(drugOfInterest, resultsIds)
resultsSmiles <- c(smilesOfInterest, resultsSmiles)

plotStructuresFromNscs(resultsIds, resultsSmiles, 
                                             titleCex=0.5, mainLabel="Fingerprint Results")

Visualize drug activity

Plot the activity of the compounds across the NCI-60

nscs <- names(results)[2:3]
plotCellMiner(drugAct=drugAct, molData=molData, plots=rep("drug", length(nscs)), nscs, NULL)

Working with Additional Drug Information

Mechanism of action (MOA)

rcellminer provides information on the mechanism of action (MOA) for a number of compounds in the database. This information gives users information on the specific biochemical interactions that a given compound participates in to produce its effect.

Get MOA information

Find known MOA drugs and organize their essential information in a table.

drugAnnot <- as(featureData(getAct(rcellminerData::drugData)), "data.frame")

knownMoaDrugs <- unique(c(getMoaToCompounds(), recursive = TRUE))

knownMoaDrugInfo <- data.frame(NSC=knownMoaDrugs, stringsAsFactors = FALSE)

knownMoaDrugInfo$Name <- drugAnnot[knownMoaDrugInfo$NSC, "NAME"]

knownMoaDrugInfo$MOA <- vapply(knownMoaDrugInfo$NSC, getMoaStr, character(1))

# Order drugs by mechanism of action.
knownMoaDrugInfo <- knownMoaDrugInfo[order(knownMoaDrugInfo$MOA), ]

Working with GI50 (Growth Inhibition 50) data

Additionally, rcellminer provides GI50 (growth inhibition 50%) values for the compounds in the database. GI50 values are similar to IC50 values, which are the concentrations that cause 50% growth inhibition, but have been renamed to emphasize the correction for the cell count at time zero. Further discussion on the assay used available on the DTP website.

Get GI50 values

Compute GI50 data matrix for known MOA drugs.

negLogGI50Data <- getDrugActivityData(nscSet = knownMoaDrugInfo$NSC)

gi50Data <- 10^(-negLogGI50Data)

Construct integrated data table (drug information and NCI-60 GI50 activity).

knownMoaDrugAct <- as.data.frame(cbind(knownMoaDrugInfo, gi50Data), stringsAsFactors = FALSE)

# This table can be written out to a file
#write.table(knownMoaDrugAct, file="knownMoaDrugAct.txt", quote=FALSE, sep="\t", row.names=FALSE, col.names=TRUE, na="NA")

Accessing rcellminer Shiny Apps

Several Shiny-based applications have been embedded into rcellminer to simplify exploration of the CellMiner data.

Plot Comparison Application

The “Comparison” application allows users to plot any two variables from the CellMiner data against each other. It additionally allows users to search for compound NSC IDs using names and mechanisms of action.

runShinyComparePlots()

Compound Browser Application

The “Compound Browser”" application allows users to see information about each compound, including structures and any repeat assay information.

runShinyCompoundBrowser()

Structure Comparison Application

The “Structure Comparison”" application allows users to identify similar compounds within the dataset either by NSC ID or SMILES string.

runShinyCompareStructures()

Session Information

sessionInfo()
## R version 3.2.0 (2015-04-16)
## Platform: x86_64-unknown-linux-gnu (64-bit)
## Running under: Ubuntu 14.04.2 LTS
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8          LC_NUMERIC=C                 
##  [3] LC_TIME=en_US.UTF-8           LC_COLLATE=C                 
##  [5] LC_MONETARY=en_US.UTF-8       LC_MESSAGES=en_US.UTF-8      
##  [7] LC_PAPER=en_US.UTF-8          LC_NAME=en_US.UTF-8          
##  [9] LC_ADDRESS=en_US.UTF-8        LC_TELEPHONE=en_US.UTF-8     
## [11] LC_MEASUREMENT=en_US.UTF-8    LC_IDENTIFICATION=en_US.UTF-8
## 
## attached base packages:
## [1] tcltk     parallel  stats     graphics  grDevices utils     datasets 
## [8] methods   base     
## 
## other attached packages:
##  [1] sqldf_0.4-10         RSQLite_1.0.0        DBI_0.3.1           
##  [4] gsubfn_0.6-6         proto_0.3-10         rcellminerData_1.0.0
##  [7] rcellminer_1.0.1     rcdk_3.3.2           fingerprint_3.5.2   
## [10] Biobase_2.28.0       BiocGenerics_0.14.0  knitr_1.10.5        
## 
## loaded via a namespace (and not attached):
##  [1] Rcpp_0.11.6        magrittr_1.5       xtable_1.7-4      
##  [4] R6_2.0.1           stringr_1.0.0      caTools_1.17.1    
##  [7] rcdklibs_1.5.8.4   tools_3.2.0        png_0.1-7         
## [10] KernSmooth_2.23-14 htmltools_0.2.6    iterators_1.0.7   
## [13] gtools_3.4.2       yaml_2.1.13        digest_0.6.8      
## [16] rJava_0.9-6        shiny_0.12.0       formatR_1.2       
## [19] bitops_1.0-6       mime_0.3           evaluate_0.7      
## [22] rmarkdown_0.6.1    gdata_2.16.1       stringi_0.4-1     
## [25] gplots_2.17.0      BiocStyle_1.6.0    chron_2.3-45      
## [28] httpuv_1.3.2

References