diff --git a/.Rbuildignore b/.Rbuildignore new file mode 100644 index 0000000..f2ab003 --- /dev/null +++ b/.Rbuildignore @@ -0,0 +1,5 @@ +^.*\.Rproj$ +^\.Rproj\.user$ +^LICENSE\.md$ +^doc$ +^Meta$ diff --git a/.gitignore b/.gitignore index e75435c..893813d 100644 --- a/.gitignore +++ b/.gitignore @@ -1,3 +1,6 @@ +# DS Store +.DS_Store + # History files .Rhistory .Rapp.history @@ -39,11 +42,10 @@ vignettes/*.pdf # R Environment Variables .Renviron -# pkgdown site -docs/ - # translation temp files po/*~ # RStudio Connect folder rsconnect/ +inst/doc +/Meta/ diff --git a/DESCRIPTION b/DESCRIPTION new file mode 100644 index 0000000..d65ba52 --- /dev/null +++ b/DESCRIPTION @@ -0,0 +1,35 @@ +Package: PathwayEmbed +Title: Tools for Pathway-Level Embedding and Visualization in Single-Cell Data +Version: 0.0.0.9000 +Authors@R: + person("Yaqing", "Huang", email = "yaqing.huang@yale.edu", role = c("aut", "cre")) +Description: Provides tools for analyzing and visualizing pathway-level activity + in single-cell RNA-seq data. Includes functions for computing cell-wise pathway scores, + visualizing transduction states, calculating activation percentages, + and integrating pathway data with Seurat objects. +License: MIT + file LICENSE +Encoding: UTF-8 +Roxygen: list(markdown = TRUE) +RoxygenNote: 7.3.2 +Depends: + R (>= 3.5) +Imports: + readxl, + Seurat, + RColorBrewer, + ggplot2, + cowplot, + dplyr, + matrixStats, + viridis, + stats, + effsize, + tidyverse, + purrr +Suggests: + knitr, + rmarkdown, + testthat (>= 3.0.0) +Config/testthat/edition: 3 +LazyData: true +VignetteBuilder: knitr diff --git a/LICENSE b/LICENSE index 62584c7..42409af 100644 --- a/LICENSE +++ b/LICENSE @@ -1,21 +1,2 @@ -MIT License - -Copyright (c) 2024 Raredon Lab - -Permission is hereby granted, free of charge, to any person obtaining a copy -of this software and associated documentation files (the "Software"), to deal -in the Software without restriction, including without limitation the rights -to use, copy, modify, merge, publish, distribute, sublicense, and/or sell -copies of the Software, and to permit persons to whom the Software is -furnished to do so, subject to the following conditions: - -The above copyright notice and this permission notice shall be included in all -copies or substantial portions of the Software. - -THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR -IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, -FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE -AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER -LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, -OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE -SOFTWARE. +YEAR: 2025 +COPYRIGHT HOLDER: Raredon Lab diff --git a/LICENSE.md b/LICENSE.md new file mode 100644 index 0000000..5cfe77a --- /dev/null +++ b/LICENSE.md @@ -0,0 +1,21 @@ +# MIT License + +Copyright (c) 2025 Raredon Lab + +Permission is hereby granted, free of charge, to any person obtaining a copy +of this software and associated documentation files (the "Software"), to deal +in the Software without restriction, including without limitation the rights +to use, copy, modify, merge, publish, distribute, sublicense, and/or sell +copies of the Software, and to permit persons to whom the Software is +furnished to do so, subject to the following conditions: + +The above copyright notice and this permission notice shall be included in all +copies or substantial portions of the Software. + +THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, +FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE +AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER +LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, +OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE +SOFTWARE. diff --git a/NAMESPACE b/NAMESPACE new file mode 100644 index 0000000..12e3197 --- /dev/null +++ b/NAMESPACE @@ -0,0 +1,25 @@ +# Generated by roxygen2: do not edit by hand + +export(CalculatePercentage) +export(ComputeCellData) +export(LoadPathway) +export(PathwayMaxMin) +export(PlotPathway) +export(PreparePlotData) +import(RColorBrewer) +import(Seurat) +import(cowplot) +import(ggplot2) +import(matrixStats) +import(readxl) +import(tidyverse) +import(viridis) +importFrom(dplyr,"%>%") +importFrom(dplyr,bind_rows) +importFrom(effsize,cohen.d) +importFrom(matrixStats,rowMaxs) +importFrom(matrixStats,rowMins) +importFrom(purrr,map) +importFrom(stats,cmdscale) +importFrom(stats,dist) +importFrom(stats,na.omit) diff --git a/PathwayEmbed.Rproj b/PathwayEmbed.Rproj new file mode 100644 index 0000000..ac761db --- /dev/null +++ b/PathwayEmbed.Rproj @@ -0,0 +1,23 @@ +Version: 1.0 +ProjectId: 0c111876-39b0-460f-a888-db107bec1084 + +RestoreWorkspace: No +SaveWorkspace: No +AlwaysSaveHistory: Default + +EnableCodeIndexing: Yes +UseSpacesForTab: Yes +NumSpacesForTab: 2 +Encoding: UTF-8 + +RnwWeave: Sweave +LaTeX: pdfLaTeX + +AutoAppendNewline: Yes +StripTrailingWhitespace: Yes +LineEndingConversion: Posix + +BuildType: Package +PackageUseDevtools: Yes +PackageInstallArgs: --no-multiarch --with-keep.source +PackageRoxygenize: rd,collate,namespace diff --git a/R/CalculatePercentage.R b/R/CalculatePercentage.R new file mode 100644 index 0000000..b233435 --- /dev/null +++ b/R/CalculatePercentage.R @@ -0,0 +1,63 @@ +#' CalculatePercentage +#' +#' This function calculates the percentage of cells in ON (scale > 0) and OFF (scale < 0) +#' activation states within each group defined by `group_var`. If exactly two groups +#' are provided, it also computes Cohen's d effect size between their activation values. +#' +#' @name CalculatePercentage +#' @importFrom dplyr bind_rows +#' @importFrom effsize cohen.d +#' @importFrom stats na.omit +#' @param to.plot A data frame containing at least a `scale` column and a grouping column. +#' @param group_var A string specifying the grouping variable (e.g., "genotype", "treatment"). +#' +#' @return A data frame with the percentage of ON/OFF cells and Cohen's d (if applicable). +#' @examples +#' data(fake_to_plot) +#' CalculatePercentage(fake_to_plot, "genotype") +#' @export +CalculatePercentage <- function(to.plot, group_var){ + # Make sure there is scale data + stopifnot("scale" %in% names(to.plot)) + + # Make sure no NA + groups <- unique(na.omit(to.plot[[group_var]])) + results <- list() + + for (g in groups) { + subset_data <- to.plot[to.plot[[group_var]] == g, ] + total <- nrow(subset_data) + + # Calculate how many cells are in on/off status + on <- sum(subset_data[["scale"]] > 0, na.rm = TRUE) + off <- sum(subset_data[["scale"]] < 0, na.rm = TRUE) + + # Calculate percentages of on/off cells + results[[as.character(g)]] <- list( + percentage_on = round(100 * on / total, 2), + percentage_off = round(100 * off / total, 2) + ) + } + + # When there are two groups in comparison, Cohen's d — a measure of effect size — will be applied for statistic purpose + if (length(groups) == 2) { + g1 <- groups[1] + g2 <- groups[2] + vec1 <- to.plot[to.plot[[group_var]] == g1, "scale"] + vec2 <- to.plot[to.plot[[group_var]] == g2, "scale"] + + # Computes Cohen's d between two numeric vectors (vec1 and vec2) and extracts the estimated value of the effect size. + cohens_d_val <- cohen.d(vec1, vec2)$estimate + # |d value|: 0 - 0.2, effect size is negligible + # |d value|: 0.2 - 0.5: small effect + # |d value|: 0.5 - 0.8: medium effect + # |d value|: > 0.8: large effect + + results[[as.character(g1)]]$cohens_d <- cohens_d_val + results[[as.character(g2)]]$cohens_d <- cohens_d_val + } + + # Make a dataframe for the output + df <- bind_rows(results, .id = "group") + return(df) +} diff --git a/R/ComputeCellData.R b/R/ComputeCellData.R new file mode 100644 index 0000000..94565ac --- /dev/null +++ b/R/ComputeCellData.R @@ -0,0 +1,145 @@ +#' ComputeCellData +#' +#' A function computes cell status for a given pathway in single-cell RNA-seq data, +#' based on the distance between genes in a specified pathway. The distance is computed +#' for each batch of cells, and classical multidimensional scaling (MDS) is used to +#' visualize the pathway expression across cells. +#' +#' @name ComputeCellData +#' @import Seurat +#' @importFrom matrixStats rowMins rowMaxs +#' @importFrom stats dist cmdscale +#' @importFrom dplyr %>% +#' @importFrom purrr map +#' @import tidyverse +#' @import viridis +#' +#' @param x A `Seurat` object containing single-cell RNA sequencing data. +#' @param pathway A `character` string specifying the pathway name. This should match a pathway used by `LoadPathway()`. +#' @param distance.method A `character` string specifying the distance metric to use.Default is "manhattan". +#' Options include: `"manhattan"`, `"euclidean"`, `"canberra"`, `"binary"`, `"minkowski"` +#' @param batch.size An `integer` specifying the number of cells to process per batch. Default is 1000. +#' @param scale.data A `logical` indicating whether to use scaled data (`scale.data = TRUE`) or normalized data. Default is `TRUE`. +#' +#' @return A data frame of MDS results with normalized values per cell, suitable for thresholding or visualization. +#' +#' @examples +#' data(fake_test_object) +#' ComputeCellData(fake_test_object, pathway = "Wnt", distance.method = "manhattan", batch.size = 2000) +#' +#' @export +ComputeCellData <- function(x, pathway, distance.method, batch.size = batch.size, scale.data = TRUE){ + + # Get pathway data + pathwaydata <- LoadPathway(pathway) + names <- c(pathwaydata[[1]]) + + # Use only genes present in Seurat object + valid_names <- intersect(names, rownames(x)) + if (length(valid_names) == 0) { + stop("No valid pathway genes found in the Seurat object.") + } + x <- ScaleData(x, features = valid_names) + + # Extract expression data from the desired slot + slot_use <- if (scale.data) "scale.data" else "data" + expr_data <- GetAssayData(x, assay = "RNA", slot = slot_use)[valid_names, , drop = FALSE] + + # Pathway max and min + pathway.stat <- PathwayMaxMin(x, pathway) + + # Get cell indices + cell_id <- colnames(expr_data) + + # Shuffle cell indices + shuffled_cell_id <- sample(cell_id) + + # Split shuffled indices into batches + # Check if batch.size is provided; if not, set default and message + if (missing(batch.size) || is.null(batch.size)) { + message("Parameter 'batch.size' is missing or NULL. Setting default batch size to 1000.") + batch.size <- 1000 + } + + # Define batch size + batch_size <- batch.size + + batches <- split(shuffled_cell_id, ceiling(seq_along(shuffled_cell_id) / batch.size)) + + # Subset expression data into chunks based on sampled indices + expr_chunks <- lapply(batches, function(cols) expr_data[, cols, drop = FALSE]) + + # For each expr_chunks, do distance measuring + # Initialize list to store results + batch_results <- list() + + # Loop through batches of 500 cells + for (i in seq_len(length(batches))) { + + message("Processing batch ", i) + + # Extract and convert expression chunk + expr_data <- expr_chunks[[i]] + temp.data.batch <- as.data.frame(expr_data) + + # Merge along columns + pathwaytempdata <- cbind(pathway.stat, temp.data.batch) + + # Check for enough cells (columns) + if (ncol(pathwaytempdata) < 2) { + warning("Batch ", i, " does not have enough cells for distance calculation. Skipping...") + next + } + + # Check if distance.method is provided; if not, set default and message + if (missing(distance.method) || is.null(distance.method)) { + message("Parameter 'distance.method' is missing or NULL. Setting default distance.method to 'manhattan'.") + distance.method <- "manhattan" + } + + # Distance calculation + message("Computing distance...") + d <- dist(t(pathwaytempdata), method = distance.method) + # "manhattan" is sum of absolute differences (city block distance), good for sparse data (gene expression) + # "euclidean" is stratight-line distance, is useful for PCA clustering + # "canberra" is weighted distance, is also good for sparse data and when values have very different scales + # "binary" is distance based on presence/absence (0/1) + # "minkowski" is generalization of euclidean & manhattan, tunable using p parameter + # choose "manhattan" as it works well for high-dimensional data and less sensitive to large outliers than euclidean distance + + # MDS + message("Running MDS ...") + fit <- cmdscale(d, eig = TRUE, k = 1) + message("MDS finished") + + # Normalize the MDS values + temp.data.mds <- as.data.frame(fit$points) + colnames(temp.data.mds) <- "V1" + V1_min <- min(temp.data.mds$V1, na.rm = TRUE) + V1_max <- max(temp.data.mds$V1, na.rm = TRUE) + + if (V1_max == V1_min) { + temp.data.mds$normalized <- 0 + } else { + temp.data.mds$normalized <- (temp.data.mds$V1 - V1_min) / (V1_max - V1_min) + } + + # Store result + batch_results[[i]] <- temp.data.mds + + # Report + cat("Batch", i, "processed with", ncol(expr_data), "cells\n") + } + + final_mds <- do.call(rbind, batch_results) # Merge all batch MDS results + + return(final_mds) +} + +# using sample +# barcode list (randomization) +# list of data chunk +# make these list independent +# short loop +# lappy, sapply (list-wide operation) +# https://www.r-bloggers.com/2022/03/complete-tutorial-on-using-apply-functions-in-r/ diff --git a/R/LoadPathway.R b/R/LoadPathway.R new file mode 100644 index 0000000..79f51d8 --- /dev/null +++ b/R/LoadPathway.R @@ -0,0 +1,27 @@ +#' LoadPathway +#' +#' This function reads pathway data from the package's built-in Excel file. +#' +#' @name LoadPathway +#' @param pathway A `character` string specifying the pathway name. +#' @return A data frame with pathway data. +#' @examples +#' LoadPathway("Wnt") +#' @import readxl +#' @export +LoadPathway <- function(pathway) { + file_path <- system.file("extdata", "Pathway_Embedding.xlsx", package = "PathwayEmbed") + + if (file_path == "") { + stop("Pathway data file not found. Ensure the package is installed correctly.") + } + + # Read the specified sheet + data <- readxl::read_excel(file_path, sheet = pathway) + # extract the molecules in the pathway + pathway.molecules <- c(data[["Molecules"]]) + # extract the coefficients of the molecules in the pathway + pathway.coefficients <- as.numeric(c(data[["Coefficients"]])) + + return(data) +} diff --git a/R/PathwayMaxMin.R b/R/PathwayMaxMin.R new file mode 100644 index 0000000..71a8bdc --- /dev/null +++ b/R/PathwayMaxMin.R @@ -0,0 +1,84 @@ +#' PathwayMaxMin +#' +#' A function to obtain the hypothetical max and min activation status of selected pathway for a given scRNA seq data set +#' +#' @name PathwayMaxMin +#' @import Seurat +#' @import tidyverse +#' @import viridis +#' @importFrom matrixStats rowMins rowMaxs +#' +#' @param x A Seurat Object. +#' @param pathway A `character` string specifying the pathway name. +#' @param scale.data A `logical` indicating whether to use scaled data (`scale.data = TRUE`) or normalized data. Default is `TRUE`. +#' @return The hypothetical value for Pathway on and off (max and min value for features) +#' @examples +#' data(fake_test_object) # load the fake test data +#' PathwayMaxMin(fake_test_object, "Wnt") +#' @export +PathwayMaxMin <- function(x, pathway, scale.data = TRUE) { + + # Define pathway parameters using LoadPathway + pathwaydata <- LoadPathway(pathway) # load pathway data + names <- c(pathwaydata[[1]]) # molecule names + pathway.on <- as.numeric(c(pathwaydata[[2]])) # coefficients + names(pathway.on) <- names + pathway.off <- -pathway.on # define off status + + # Use only genes present in Seurat object + valid_names <- intersect(names, rownames(x)) + if (length(valid_names) == 0) { + stop("No valid pathway genes found in the Seurat object.") + } + pathway.on <- pathway.on[valid_names] + pathway.off <- pathway.off[valid_names] + + # Extract expression data from the desired slot + x <- ScaleData(x, features = valid_names) + slot_use <- if (scale.data) "scale.data" else "data" + expr_data <- GetAssayData(x, assay = "RNA", slot = slot_use)[valid_names, , drop = FALSE] + + # Ensure it's a data frame + expr_data <- as.data.frame(expr_data) + + # Max and min value for genes in the pathway + # Compute row-wise min and max values + ranges <- cbind( + rowMins(as.matrix(expr_data), na.rm = FALSE), + rowMaxs(as.matrix(expr_data), na.rm = FALSE) + ) + + # Scale the ON/OFF states to the extrema of these ranges for each features + for (i in seq_along(pathway.on)) { + feature_name <- names(pathway.on[i]) + + if (!feature_name %in% rownames(ranges)) { + warning(paste("Feature", feature_name, "not found in ranges!")) + next # Skip iteration if feature is missing + } + if (pathway.on[i] < 0) { + pathway.on[i] <- ranges[feature_name, 1] # min for ON + } else { + pathway.on[i] <- ranges[feature_name, 2] # max for ON + } + } + for (i in seq_along(pathway.off)) { # Safer indexing + feature_name <- names(pathway.off[i]) # Get feature name + + if (!feature_name %in% rownames(ranges)) { # Check if feature exists in ranges + warning(paste("Feature", feature_name, "not found in ranges! Skipping...")) + next # Skip to the next iteration if missing + } + + # Assign min or max based on value + pathway.off[i] <- ifelse(pathway.off[i] < 0, + ranges[feature_name, 1], # Min for OFF + ranges[feature_name, 2]) # Max for OFF + } + + + # Bind on and off states + pathway.stat <- data.frame(pathway.on,pathway.off) + + return(pathway.stat) +} diff --git a/R/PlotPathway.R b/R/PlotPathway.R new file mode 100644 index 0000000..d72d7f1 --- /dev/null +++ b/R/PlotPathway.R @@ -0,0 +1,41 @@ +#' PlotPathway +#' +#' A function to plot the Pathway activation status +#' +#' @name PlotPathway +#' @param to.plot A data frame with pathway activation values genereated by PreparePlotData +#' @param pathway A character string indicating the pathway name. +#' @param group Column name to group and color by (e.g., genotype). +#' @param color A character vector of colors to use for fill and outline. +#' @return A ggplot object. +#' @examples +#' data(fake_to_plot) +#' PlotPathway(to.plot = fake_to_plot,"Wnt","genotype",color = c("#ae282c", "#2066a8")) +#' @export +PlotPathway <- function (to.plot, pathway, group, color){ + + #color has to be assigned + plot.total <- ggplot(data=to.plot, + aes(x=scale, + group = .data[[group]], + fill= .data[[group]], + color= .data[[group]]))+ + + geom_density(alpha = 0.5) + # Example: Density plot + labs(title = paste(pathway, "Pathway"), + x = "Relative Transduction State", + y = "Population Density") + + scale_fill_manual(values = color) + # Set fixed colors + scale_color_manual(values = color) + + theme_classic() + + geom_vline(xintercept=0, linetype="dotted", + color = "black", size=0.5) + + return(plot.total) +} + + + + + + diff --git a/R/PreparePlotData.R b/R/PreparePlotData.R new file mode 100644 index 0000000..05e877c --- /dev/null +++ b/R/PreparePlotData.R @@ -0,0 +1,44 @@ +#' A function to prepare the signal transduction dataframe for plotting +#' @name PreparePlotData +#' @import Seurat +#' @import RColorBrewer +#' @import ggplot2 +#' @import cowplot +#' @import tidyverse +#' @import viridis +#' @import matrixStats +#' +#' @param x A `Seurat` object containing single-cell RNA sequencing data. +#' @param final_mds A 'dataframe' output from ComputeCellData. +#' @param group group for the comparision +#' @return data for plotting +#' @examples +#' data(fake_test_object) +#' data(fake_final_mds) +#' PreparePlotData(fake_test_object, fake_final_mds, "genotype") +#' @export +PreparePlotData <- function(x, final_mds, group){ + + # Make a data frame from final_mds + to.plot <- as.data.frame(final_mds) + + # Sometimes, the rownames changed in last step, to make them consistent with meta.data + rownames(to.plot) <- gsub("\\.", "-", rownames(to.plot)) + + # Add group into the dataframe and assign group + to.plot[[group]] <- NA + meta.data <- x@meta.data + to.plot[rownames(meta.data),][[group]] <- as.character(meta.data[[group]]) + + # Get ride of non-cell rows + to.plot <- to.plot[!is.na(to.plot[[group]]), ] + + # Scale + to.plot$scale <- scale(to.plot$normalized,center = T)[,1] + + + return(to.plot) +} + + + diff --git a/R/data_documentation.R b/R/data_documentation.R new file mode 100644 index 0000000..e5f14f9 --- /dev/null +++ b/R/data_documentation.R @@ -0,0 +1,55 @@ +#' Example Seurat Object for Testing +#' +#' A simulated Seurat object with fake gene expression data for the Wnt signaling pathway. +#' This Seurat object contains gene expression data from simulated cells with Wnt positive +#' and negative gene expression values. +#' +#' @format A Seurat object. The object contains: +#' \describe{ +#' \item{assays}{List of assays used for data storage. Includes RNA expression data.} +#' \item{meta.data}{Metadata associated with the cells. Contains information about the groups (e.g., WT vs. Mutant).} +#' \item{features}{Gene features (including Wnt pathway genes) used in the analysis.} +#' \item{cells}{Cell names, labeled as Cell1, Cell2, ..., CellN.} +#' } +#' @source Simulated for demonstration purposes. +#' @usage data(fake_test_object) +"fake_test_object" + + +#' Example Cell Status and Normalized Data +#' +#' A dataset generated by `ComputeCellData` applied to `fake_test_object`. +#' Contains cell status and normalized values. +#' +#' @format A data frame with the following columns: +#' \describe{ +#' \item{V1}{A numerical value presenting the status of the cell} +#' \item{normalized}{Numerical value representing normalized data} +#' } +#' @usage data(fake_final_mds) +#' @examples +#' data(fake_final_mds) +#' head(fake_final_mds) +#' @keywords datasets +"fake_final_mds" + +#' Example Processed Data for Plotting +#' +#' A dataset generated by running `PreparePlotData` on `fake_test_object` and `fake_final_mds`. +#' Contains processed data ready for visualization, with the following features: +#' +#' @format A data frame with the following columns: +#' \describe{ +#' \item{V1}{A numerical or categorical value depending on the specific analysis} +#' \item{normalized}{Normalized numerical value representing the cell's data} +#' \item{genotype}{Group classification of the cell (e.g., "WT", "Mutant")} +#' \item{scale}{Scaled data for visualization purposes} +#' } +#' @usage data(fake_to_plot) +#' @examples +#' data(fake_to_plot) +#' head(fake_to_plot) +#' @keywords datasets +"fake_to_plot" + + diff --git a/README.md b/README.md index 183b71d..6cc0937 100644 --- a/README.md +++ b/README.md @@ -1 +1,50 @@ -# PathwayState \ No newline at end of file +# PathwayEmbed + +## We are focusing on 1-D embeddings of pathway state. + + +# PathwayEmbed + +[](https://github.com/RaredonLab/PathwayEmbed/actions) +[](https://opensource.org/licenses/MIT) + +PathwayEmbed is an R package for quantifying and visualizing intracellular signaling pathway activation from transcriptomic data, integrating pathway topology and gene expression data. + +--- + +## Installation + +You can install the released version of PathwayEmbed from GitHub using: + +```r +# Install remotes if you haven't already +if (!requireNamespace("remotes", quietly = TRUE)) { + install.packages("remotes") +} + +remotes::install_github("RaredonLab/PathwayEmbed") + +``` +--- + +## Usage + +```r +library(PathwayEmbed) + +# Load example data included with the package +data(fake_test_object) + +# Compute pathway data +mds_results <- ComputeCellData(fake_test_object, pathway = "Wnt", distance.method = "manhattan", batch.size = 100) + +# Prepare data for plotting +plot_data <- PreparePlotData(fake_test_object, mds_results, group = "genotype") + +# Plot pathway activation +PlotPathway(to.plot = plot_data, pathway = "Wnt", group = "genotype", color = c("#ae282c", "#2066a8")) + +# Calculate percentage and do comparison between two groups (optional) +CalculatePercentage(to.plot = plot_data, group_var = "genotype") + +``` diff --git a/data/fake_final_mds.rda b/data/fake_final_mds.rda new file mode 100644 index 0000000..cf60cc5 Binary files /dev/null and b/data/fake_final_mds.rda differ diff --git a/data/fake_test_object.rda b/data/fake_test_object.rda new file mode 100644 index 0000000..34fd240 Binary files /dev/null and b/data/fake_test_object.rda differ diff --git a/data/fake_to_plot.rda b/data/fake_to_plot.rda new file mode 100644 index 0000000..73c3e8a Binary files /dev/null and b/data/fake_to_plot.rda differ diff --git a/doc/beta_catenin_ko.R b/doc/beta_catenin_ko.R new file mode 100644 index 0000000..ed0607c --- /dev/null +++ b/doc/beta_catenin_ko.R @@ -0,0 +1,68 @@ +## ----include = FALSE---------------------------------------------------------- +knitr::opts_chunk$set( + collapse = TRUE, + comment = "#>" +) + +## ----setup-------------------------------------------------------------------- +library(PathwayEmbed) +library(Seurat) + +url_ko <- "https://ftp.ncbi.nlm.nih.gov/geo/series/GSE233nnn/GSE233978/suppl/GSE233978_KO_filtered_feature_bc_matrix.h5" +url_wt <- "https://ftp.ncbi.nlm.nih.gov/geo/series/GSE233nnn/GSE233978/suppl/GSE233978_WT_filtered_feature_bc_matrix.h5" + + +download.file(url_ko, destfile = "GSE233978_KO_filtered_feature_bc_matrix.h5", mode = "wb") +download.file(url_wt, destfile = "GSE233978_WT_filtered_feature_bc_matrix.h5", mode = "wb") + +## ----------------------------------------------------------------------------- +# Load KO and WT expression matrices from local HDF5 files +ko_data <- Read10X_h5("GSE233978_KO_filtered_feature_bc_matrix.h5") +wt_data <- Read10X_h5("GSE233978_WT_filtered_feature_bc_matrix.h5") + +# Create Seurat objects +# Apply during object creation +ko <- CreateSeuratObject(counts = ko_data, project = "KO", min.cells = 3, min.features = 200) +wt <- CreateSeuratObject(counts = wt_data, project = "WT", min.cells = 3, min.features = 200) + + +# Add sample metadata +ko$sample <- "KO" +wt$sample <- "WT" + +# Merge and join layers +merged <- merge(ko, wt) +merged[["RNA"]] <- JoinLayers(merged[["RNA"]]) + +## ----------------------------------------------------------------------------- +# Normalize and scale +merged <- NormalizeData( + object = merged, + normalization.method = "LogNormalize", + scale.factor = 10000 +) + +merged <- FindVariableFeatures( + object = merged, + selection.method = "vst", + nfeatures = 2000 +) + +merged <- ScaleData( + object = merged, + features = VariableFeatures(object = merged) +) + +## ----------------------------------------------------------------------------- +# Compute Wnt pathway score +wnt_scores <- ComputeCellData(merged, "Wnt", distance.method = "manhattan", batch.size = 1000) + +# Prepare for plotting +plot_data <- PreparePlotData(merged, wnt_scores, group = "sample") + +# Plot +PlotPathway(plot_data, pathway = "Wnt", group = "sample", c("#f4a4a4", "#6baed6")) + +# Show percentage of high-scoring cells (optional) +CalculatePercentage(plot_data, "sample") + diff --git a/doc/beta_catenin_ko.Rmd b/doc/beta_catenin_ko.Rmd new file mode 100644 index 0000000..865a162 --- /dev/null +++ b/doc/beta_catenin_ko.Rmd @@ -0,0 +1,88 @@ +--- +title: "Beta-Catenin Knockout Analysis with PathwayEmbed" +output: rmarkdown::html_vignette +vignette: > + %\VignetteIndexEntry{Beta-Catenin Knockout Analysis} + %\VignetteEngine{knitr::rmarkdown} + %\VignetteEncoding{UTF-8} +--- + + +```{r, include = FALSE} +knitr::opts_chunk$set( + collapse = TRUE, + comment = "#>" +) +``` + + +## Load Packages and Download Data from Online Source +```{r setup} +library(PathwayEmbed) +library(Seurat) + +url_ko <- "https://ftp.ncbi.nlm.nih.gov/geo/series/GSE233nnn/GSE233978/suppl/GSE233978_KO_filtered_feature_bc_matrix.h5" +url_wt <- "https://ftp.ncbi.nlm.nih.gov/geo/series/GSE233nnn/GSE233978/suppl/GSE233978_WT_filtered_feature_bc_matrix.h5" + + +download.file(url_ko, destfile = "GSE233978_KO_filtered_feature_bc_matrix.h5", mode = "wb") +download.file(url_wt, destfile = "GSE233978_WT_filtered_feature_bc_matrix.h5", mode = "wb") +``` + +## Data Preparation +```{r} +# Load KO and WT expression matrices from local HDF5 files +ko_data <- Read10X_h5("GSE233978_KO_filtered_feature_bc_matrix.h5") +wt_data <- Read10X_h5("GSE233978_WT_filtered_feature_bc_matrix.h5") + +# Create Seurat objects +# Apply during object creation +ko <- CreateSeuratObject(counts = ko_data, project = "KO", min.cells = 3, min.features = 200) +wt <- CreateSeuratObject(counts = wt_data, project = "WT", min.cells = 3, min.features = 200) + + +# Add sample metadata +ko$sample <- "KO" +wt$sample <- "WT" + +# Merge and join layers +merged <- merge(ko, wt) +merged[["RNA"]] <- JoinLayers(merged[["RNA"]]) +``` + +## Preprocessing +Get normalized and scaled data +```{r} +# Normalize and scale +merged <- NormalizeData( + object = merged, + normalization.method = "LogNormalize", + scale.factor = 10000 +) + +merged <- FindVariableFeatures( + object = merged, + selection.method = "vst", + nfeatures = 2000 +) + +merged <- ScaleData( + object = merged, + features = VariableFeatures(object = merged) +) +``` + +## Wnt Pathway Scoring and Visualization Using Pathway Embed +```{r} +# Compute Wnt pathway score +wnt_scores <- ComputeCellData(merged, "Wnt", distance.method = "manhattan", batch.size = 1000) + +# Prepare for plotting +plot_data <- PreparePlotData(merged, wnt_scores, group = "sample") + +# Plot +PlotPathway(plot_data, pathway = "Wnt", group = "sample", c("#f4a4a4", "#6baed6")) + +# Show percentage of high-scoring cells (optional) +CalculatePercentage(plot_data, "sample") +``` diff --git a/doc/beta_catenin_ko.html b/doc/beta_catenin_ko.html new file mode 100644 index 0000000..5ffceee --- /dev/null +++ b/doc/beta_catenin_ko.html @@ -0,0 +1,600 @@ + + + + +
+ + + + + + + + + +library(PathwayEmbed)
+library(Seurat)
+#> Loading required package: SeuratObject
+#> Loading required package: sp
+#> 'SeuratObject' was built under R 4.4.1 but the current version is
+#> 4.4.2; it is recomended that you reinstall 'SeuratObject' as the ABI
+#> for R may have changed
+#>
+#> Attaching package: 'SeuratObject'
+#> The following objects are masked from 'package:base':
+#>
+#> intersect, t
+
+url_ko <- "https://ftp.ncbi.nlm.nih.gov/geo/series/GSE233nnn/GSE233978/suppl/GSE233978_KO_filtered_feature_bc_matrix.h5"
+url_wt <- "https://ftp.ncbi.nlm.nih.gov/geo/series/GSE233nnn/GSE233978/suppl/GSE233978_WT_filtered_feature_bc_matrix.h5"
+
+
+download.file(url_ko, destfile = "GSE233978_KO_filtered_feature_bc_matrix.h5", mode = "wb")
+download.file(url_wt, destfile = "GSE233978_WT_filtered_feature_bc_matrix.h5", mode = "wb")# Load KO and WT expression matrices from local HDF5 files
+ko_data <- Read10X_h5("GSE233978_KO_filtered_feature_bc_matrix.h5")
+wt_data <- Read10X_h5("GSE233978_WT_filtered_feature_bc_matrix.h5")
+
+# Create Seurat objects
+# Apply during object creation
+ko <- CreateSeuratObject(counts = ko_data, project = "KO", min.cells = 3, min.features = 200)
+wt <- CreateSeuratObject(counts = wt_data, project = "WT", min.cells = 3, min.features = 200)
+
+
+# Add sample metadata
+ko$sample <- "KO"
+wt$sample <- "WT"
+
+# Merge and join layers
+merged <- merge(ko, wt)
+#> Warning: Some cell names are duplicated across objects provided. Renaming to
+#> enforce unique cell names.
+merged[["RNA"]] <- JoinLayers(merged[["RNA"]])Get normalized and scaled data
+# Normalize and scale
+merged <- NormalizeData(
+ object = merged,
+ normalization.method = "LogNormalize",
+ scale.factor = 10000
+)
+#> Normalizing layer: counts
+
+merged <- FindVariableFeatures(
+ object = merged,
+ selection.method = "vst",
+ nfeatures = 2000
+)
+#> Finding variable features for layer counts
+
+merged <- ScaleData(
+ object = merged,
+ features = VariableFeatures(object = merged)
+)
+#> Centering and scaling data matrix# Compute Wnt pathway score
+wnt_scores <- ComputeCellData(merged, "Wnt", distance.method = "manhattan", batch.size = 1000)
+#> Centering and scaling data matrix
+#> Warning: Different features in new layer data than already exists for
+#> scale.data
+#> Warning: The `slot` argument of `GetAssayData()` is deprecated as of SeuratObject 5.0.0.
+#> ℹ Please use the `layer` argument instead.
+#> ℹ The deprecated feature was likely used in the PathwayEmbed package.
+#> Please report the issue to the authors.
+#> This warning is displayed once every 8 hours.
+#> Call `lifecycle::last_lifecycle_warnings()` to see where this warning was
+#> generated.
+#> Centering and scaling data matrix
+#> Processing batch 1
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 1 processed with 1000 cells
+#> Processing batch 2
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 2 processed with 1000 cells
+#> Processing batch 3
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 3 processed with 1000 cells
+#> Processing batch 4
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 4 processed with 1000 cells
+#> Processing batch 5
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 5 processed with 1000 cells
+#> Processing batch 6
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 6 processed with 1000 cells
+#> Processing batch 7
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 7 processed with 1000 cells
+#> Processing batch 8
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 8 processed with 1000 cells
+#> Processing batch 9
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 9 processed with 1000 cells
+#> Processing batch 10
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 10 processed with 1000 cells
+#> Processing batch 11
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 11 processed with 1000 cells
+#> Processing batch 12
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 12 processed with 1000 cells
+#> Processing batch 13
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 13 processed with 1000 cells
+#> Processing batch 14
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 14 processed with 1000 cells
+#> Processing batch 15
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 15 processed with 1000 cells
+#> Processing batch 16
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 16 processed with 1000 cells
+#> Processing batch 17
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 17 processed with 1000 cells
+#> Processing batch 18
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 18 processed with 1000 cells
+#> Processing batch 19
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 19 processed with 1000 cells
+#> Processing batch 20
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 20 processed with 1000 cells
+#> Processing batch 21
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 21 processed with 1000 cells
+#> Processing batch 22
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 22 processed with 1000 cells
+#> Processing batch 23
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 23 processed with 1000 cells
+#> Processing batch 24
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 24 processed with 1000 cells
+#> Processing batch 25
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 25 processed with 1000 cells
+#> Processing batch 26
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 26 processed with 1000 cells
+#> Processing batch 27
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 27 processed with 1000 cells
+#> Processing batch 28
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 28 processed with 735 cells
+
+# Prepare for plotting
+plot_data <- PreparePlotData(merged, wnt_scores, group = "sample")
+
+# Plot
+PlotPathway(plot_data, pathway = "Wnt", group = "sample", c("#f4a4a4", "#6baed6"))This vignette demonstrates how to use the PathwayEmbed package to +compute and visualize pathway activation using single-cell +transcriptomic data. We use the example dataset fake_test_object +included with the package.
+# Calculate pathway activation using MDS
+# Default batch.size is set to 1000
+mds_results <- ComputeCellData(
+ fake_test_object,
+ pathway = "Wnt",
+ distance.method = "manhattan"
+)
+#> Centering and scaling data matrix
+#> Centering and scaling data matrix
+#> Parameter 'batch.size' is missing or NULL. Setting default batch size to 1000.
+#> Processing batch 1
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 1 processed with 1000 cells
+#> Processing batch 2
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 2 processed with 1000 cells# Visualize 2D MDS embedding colored by genotype
+PlotPathway(
+ to.plot = plot_data,
+ pathway = "Wnt",
+ group = "genotype",
+ color = c("#ae282c", "#2066a8")
+)# Calculate % of cells per group with high pathway activation
+CalculatePercentage(
+ to.plot = plot_data,
+ group_var = "genotype"
+)
+#> # A tibble: 2 × 4
+#> group percentage_on percentage_off cohens_d
+#> <chr> <dbl> <dbl> <dbl>
+#> 1 WT 17.9 82.1 -1.97
+#> 2 Mutant 94.9 5.1 -1.97knitr::opts_chunk$set(echo = TRUE)
+
+# load library
+library(PathwayEmbed)
+library(Seurat)
+library(ggplot2)
+library(viridis)## Loading required package: viridisLite
+
+The files can be downloaded from figshare via below link:
+Huang, Yaqing (2025). dat3.with.niches.norm.Robj. figshare. Dataset. +https://doi.org/10.6084/m9.figshare.29649995.v1
+Huang, Yaqing (2025). dat4.with.niches.norm.Robj. figshare. Dataset. +https://doi.org/10.6084/m9.figshare.29649989.v1
+Huang, Yaqing (2025). dat1.with.niches.norm.Robj. figshare. Dataset. +https://doi.org/10.6084/m9.figshare.29649992.v1
+Huang, Yaqing (2025). dat2.with.niches.norm.Robj. figshare. Dataset. +https://doi.org/10.6084/m9.figshare.29649986.v1
+# load data
+load("dat1.with.niches.norm.Robj")
+load("dat2.with.niches.norm.Robj")
+load("dat3.with.niches.norm.Robj")
+load("dat4.with.niches.norm.Robj")
+
+# Merge together
+merged_spatial <- merge(
+ dat1, y = c(dat2, dat3, dat4))
+
+# Set Default Assay to be "RNA"
+DefaultAssay(merged_spatial) <- "RNA"Compute score for Wnt, Notch, Hippo, Tgfb, and HIF-1a pathways for +the merged subject using ‘ComputeCellData’ in PathwayEmbed
+# Compute the score for each pathway
+Wnt_mds <- ComputeCellData(merged_spatial, "Wnt", "manhattan", batch.size = 1000)
+Notch_mds <- ComputeCellData(merged_spatial, "Notch", "manhattan", batch.size = 1000)
+Hippo_mds <- ComputeCellData(merged_spatial, "Hippo", "manhattan", batch.size = 1000)
+Tgfb_mds <- ComputeCellData(merged_spatial, "Tgfb", "manhattan", batch.size = 1000)
+HIF1a_mds <- ComputeCellData(merged_spatial, "HIF-1a", "manhattan", batch.size = 1000)
+
+# Process the mds
+Wnt_to.plot <- PreparePlotData(merged_spatial, Wnt_mds, "timepoint")
+Notch_to.plot <- PreparePlotData(merged_spatial, Notch_mds, "timepoint")
+Hippo_to.plot <- PreparePlotData(merged_spatial, Hippo_mds, "timepoint")
+Tgfb_to.plot <- PreparePlotData(merged_spatial, Tgfb_mds, "timepoint")
+HIF1a_to.plot <- PreparePlotData(merged_spatial, HIF1a_mds, "timepoint")
+
+# Combine to list
+pathway_list <- list(
+ Wnt = Wnt_to.plot,
+ Notch = Notch_to.plot,
+ Hippo = Hippo_to.plot,
+ Tgfb = Tgfb_to.plot,
+ HIF1a = HIF1a_to.plot
+)# Color set-up
+magma_colors <- c("#000004FF", "#721F81FF", "#F1605DFF", "#5A90E6")
+
+# Desired timepoint order
+ordered_timepoints <- c("E9.5", "E10.5", "E11.5", "E12.5")
+
+# Reorder timepoint levels
+for (name in names(pathway_list)) {
+ pathway_list[[name]]$timepoint <- factor(pathway_list[[name]]$timepoint, levels = ordered_timepoints)
+}# Loop through each pathway and generate/save the plot
+for (i in seq_along(pathway_list)) {
+ # Generate the plot
+ p <- PlotPathway(pathway_list[[i]], names(pathway_list)[i], "timepoint", magma_colors) +
+ facet_wrap(~timepoint, ncol = 1)
+ print(p)
+}# Step 1: Create named score vectors for each pathway
+score_list <- lapply(pathway_list, function(df) {
+ s <- df$scale
+ names(s) <- rownames(df)
+ return(s)
+})
+
+# Step 2: Add each pathway score to dat1–dat4
+for (i in 1:4) {
+ dat <- get(paste0("dat", i)) # get dat1, dat2, ...
+
+ for (pathway_name in names(score_list)) {
+ score_vec <- score_list[[pathway_name]]
+ dat[[paste0(pathway_name, "_score")]] <- score_vec[colnames(dat)]
+ }
+
+ assign(paste0("dat", i), dat) # assign back to dat1, dat2, etc.
+}
+
+
+# List of Seurat objects
+dat_list <- list(dat1, dat2, dat3, dat4)
+names(dat_list) <- paste0("dat", 1:4)
+
+# List of pathways
+pathways <- names(pathway_list) # e.g., "Wnt", "Notch", etc.# Function to extract
+extract_pathway_df <- function(seu, pathway, sample_name = "sample") {
+ coords <- as.data.frame(Embeddings(seu[["spatial"]]))
+ colnames(coords) <- c("x", "y")
+ coords$score <- seu[[paste0(pathway, "_score")]][rownames(coords), 1]
+ coords$sample <- sample_name
+ return(coords)
+}
+
+# Set list to save the coordinates
+combined_df_lists <- list()
+
+# For loop for all pathways
+for (pathway in pathways) {
+ pathway_df_list <- mapply(
+ FUN = extract_pathway_df,
+ seu = dat_list,
+ sample_name = names(dat_list),
+ MoreArgs = list(pathway = pathway),
+ SIMPLIFY = FALSE
+ )
+
+ combined_df <- do.call(rbind, pathway_df_list)
+ combined_df_lists[[pathway]] <- combined_df
+}limits_list <- list(
+ Wnt = c(-3, 4),
+ Notch = c(-3, 4),
+ Hippo = c(-2, 3),
+ Tgfb = c(-2, 3),
+ HIF1a = c(-3, 5)
+)
+
+for (pathway in names(combined_df_lists)) {
+ combined_df <- combined_df_lists[[pathway]]
+ selected_limits <- limits_list[[pathway]]
+
+ p <- ggplot(combined_df, aes(x = x, y = y, color = score)) +
+ geom_point(size = 0.3) +
+ scale_color_viridis_c(
+ option = "magma",
+ name = paste0(pathway, "_score"),
+ limits = selected_limits,
+ oob = scales::squish
+ ) +
+ scale_y_reverse() +
+ coord_fixed() +
+ theme_void() +
+ theme(legend.position = "right")
+
+ print(p)
+}YEAR: 2025 +COPYRIGHT HOLDER: Raredon Lab ++ +
Copyright (c) 2025 Raredon Lab
+Permission is hereby granted, free of charge, to any person obtaining a copy of this software and associated documentation files (the “Software”), to deal in the Software without restriction, including without limitation the rights to use, copy, modify, merge, publish, distribute, sublicense, and/or sell copies of the Software, and to permit persons to whom the Software is furnished to do so, subject to the following conditions:
+The above copyright notice and this permission notice shall be included in all copies or substantial portions of the Software.
+THE SOFTWARE IS PROVIDED “AS IS”, WITHOUT WARRANTY OF ANY KIND, EXPRESS OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE.
+beta_catenin_ko.Rmd
+library(PathwayEmbed)
+library(Seurat)
+#> Loading required package: SeuratObject
+#> Loading required package: sp
+#> 'SeuratObject' was built under R 4.4.1 but the current version is
+#> 4.4.2; it is recomended that you reinstall 'SeuratObject' as the ABI
+#> for R may have changed
+#>
+#> Attaching package: 'SeuratObject'
+#> The following objects are masked from 'package:base':
+#>
+#> intersect, t
+
+url_ko <- "https://ftp.ncbi.nlm.nih.gov/geo/series/GSE233nnn/GSE233978/suppl/GSE233978_KO_filtered_feature_bc_matrix.h5"
+url_wt <- "https://ftp.ncbi.nlm.nih.gov/geo/series/GSE233nnn/GSE233978/suppl/GSE233978_WT_filtered_feature_bc_matrix.h5"
+
+
+download.file(url_ko, destfile = "GSE233978_KO_filtered_feature_bc_matrix.h5", mode = "wb")
+download.file(url_wt, destfile = "GSE233978_WT_filtered_feature_bc_matrix.h5", mode = "wb")
+# Load KO and WT expression matrices from local HDF5 files
+ko_data <- Read10X_h5("GSE233978_KO_filtered_feature_bc_matrix.h5")
+wt_data <- Read10X_h5("GSE233978_WT_filtered_feature_bc_matrix.h5")
+
+# Create Seurat objects
+# Apply during object creation
+ko <- CreateSeuratObject(counts = ko_data, project = "KO", min.cells = 3, min.features = 200)
+wt <- CreateSeuratObject(counts = wt_data, project = "WT", min.cells = 3, min.features = 200)
+
+
+# Add sample metadata
+ko$sample <- "KO"
+wt$sample <- "WT"
+
+# Merge and join layers
+merged <- merge(ko, wt)
+#> Warning: Some cell names are duplicated across objects provided. Renaming to
+#> enforce unique cell names.
+merged[["RNA"]] <- JoinLayers(merged[["RNA"]])Get normalized and scaled data
+
+# Normalize and scale
+merged <- NormalizeData(
+ object = merged,
+ normalization.method = "LogNormalize",
+ scale.factor = 10000
+)
+#> Normalizing layer: counts
+
+merged <- FindVariableFeatures(
+ object = merged,
+ selection.method = "vst",
+ nfeatures = 2000
+)
+#> Finding variable features for layer counts
+
+merged <- ScaleData(
+ object = merged,
+ features = VariableFeatures(object = merged)
+)
+#> Centering and scaling data matrix
+# Compute Wnt pathway score
+wnt_scores <- ComputeCellData(merged, "Wnt", distance.method = "manhattan", batch.size = 1000)
+#> Centering and scaling data matrix
+#> Warning: Different features in new layer data than already exists for
+#> scale.data
+#> Warning: The `slot` argument of `GetAssayData()` is deprecated as of SeuratObject 5.0.0.
+#> ℹ Please use the `layer` argument instead.
+#> ℹ The deprecated feature was likely used in the PathwayEmbed package.
+#> Please report the issue to the authors.
+#> This warning is displayed once every 8 hours.
+#> Call `lifecycle::last_lifecycle_warnings()` to see where this warning was
+#> generated.
+#> Centering and scaling data matrix
+#> Processing batch 1
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 1 processed with 1000 cells
+#> Processing batch 2
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 2 processed with 1000 cells
+#> Processing batch 3
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 3 processed with 1000 cells
+#> Processing batch 4
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 4 processed with 1000 cells
+#> Processing batch 5
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 5 processed with 1000 cells
+#> Processing batch 6
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 6 processed with 1000 cells
+#> Processing batch 7
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 7 processed with 1000 cells
+#> Processing batch 8
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 8 processed with 1000 cells
+#> Processing batch 9
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 9 processed with 1000 cells
+#> Processing batch 10
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 10 processed with 1000 cells
+#> Processing batch 11
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 11 processed with 1000 cells
+#> Processing batch 12
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 12 processed with 1000 cells
+#> Processing batch 13
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 13 processed with 1000 cells
+#> Processing batch 14
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 14 processed with 1000 cells
+#> Processing batch 15
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 15 processed with 1000 cells
+#> Processing batch 16
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 16 processed with 1000 cells
+#> Processing batch 17
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 17 processed with 1000 cells
+#> Processing batch 18
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 18 processed with 1000 cells
+#> Processing batch 19
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 19 processed with 1000 cells
+#> Processing batch 20
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 20 processed with 1000 cells
+#> Processing batch 21
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 21 processed with 1000 cells
+#> Processing batch 22
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 22 processed with 1000 cells
+#> Processing batch 23
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 23 processed with 1000 cells
+#> Processing batch 24
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 24 processed with 1000 cells
+#> Processing batch 25
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 25 processed with 1000 cells
+#> Processing batch 26
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 26 processed with 1000 cells
+#> Processing batch 27
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 27 processed with 1000 cells
+#> Processing batch 28
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 28 processed with 735 cells
+
+# Prepare for plotting
+plot_data <- PreparePlotData(merged, wnt_scores, group = "sample")
+
+# Plot
+PlotPathway(plot_data, pathway = "Wnt", group = "sample", c("#f4a4a4", "#6baed6"))
+
+# Show percentage of high-scoring cells (optional)
+CalculatePercentage(plot_data, "sample")
+#> # A tibble: 2 × 4
+#> group percentage_on percentage_off cohens_d
+#> <chr> <dbl> <dbl> <dbl>
+#> 1 KO 31.8 68.2 -0.447
+#> 2 WT 46.9 53.1 -0.447examples.RmdThis vignette demonstrates how to use the PathwayEmbed package to +compute and visualize pathway activation using single-cell +transcriptomic data. We use the example dataset fake_test_object +included with the package.
+
+# Calculate pathway activation using MDS
+# Default batch.size is set to 1000
+mds_results <- ComputeCellData(
+ fake_test_object,
+ pathway = "Wnt",
+ distance.method = "manhattan"
+)
+#> Centering and scaling data matrix
+#> Warning: The `slot` argument of `GetAssayData()` is deprecated as of SeuratObject 5.0.0.
+#> ℹ Please use the `layer` argument instead.
+#> ℹ The deprecated feature was likely used in the PathwayEmbed package.
+#> Please report the issue to the authors.
+#> This warning is displayed once every 8 hours.
+#> Call `lifecycle::last_lifecycle_warnings()` to see where this warning was
+#> generated.
+#> Centering and scaling data matrix
+#> Parameter 'batch.size' is missing or NULL. Setting default batch size to 1000.
+#> Processing batch 1
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 1 processed with 1000 cells
+#> Processing batch 2
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 2 processed with 1000 cells
+# Format MDS results and metadata for plotting
+plot_data <- PreparePlotData(
+ fake_test_object,
+ mds_results,
+ group = "genotype"
+)
+# Visualize 2D MDS embedding colored by genotype
+PlotPathway(
+ to.plot = plot_data,
+ pathway = "Wnt",
+ group = "genotype",
+ color = c("#ae282c", "#2066a8")
+)
+# Calculate % of cells per group with high pathway activation
+CalculatePercentage(
+ to.plot = plot_data,
+ group_var = "genotype"
+)
+#> # A tibble: 2 × 4
+#> group percentage_on percentage_off cohens_d
+#> <chr> <dbl> <dbl> <dbl>
+#> 1 Mutant 94.9 5.1 1.97
+#> 2 WT 17.7 82.3 1.97spatial_pathway.Rmd
+knitr::opts_chunk$set(echo = TRUE)
+
+# load library
+library(PathwayEmbed)
+library(Seurat)## Loading required package: SeuratObject
+## Loading required package: sp
+## 'SeuratObject' was built under R 4.4.1 but the current version is
+## 4.4.2; it is recomended that you reinstall 'SeuratObject' as the ABI
+## for R may have changed
+##
+## Attaching package: 'SeuratObject'
+## The following objects are masked from 'package:base':
+##
+## intersect, t
+
+## Loading required package: viridisLite
+
+The files can be downloaded from figshare via below link:
+Huang, Yaqing (2025). dat3.with.niches.norm.Robj. figshare. Dataset. +https://doi.org/10.6084/m9.figshare.29649995.v1
+Huang, Yaqing (2025). dat4.with.niches.norm.Robj. figshare. Dataset. +https://doi.org/10.6084/m9.figshare.29649989.v1
+Huang, Yaqing (2025). dat1.with.niches.norm.Robj. figshare. Dataset. +https://doi.org/10.6084/m9.figshare.29649992.v1
+Huang, Yaqing (2025). dat2.with.niches.norm.Robj. figshare. Dataset. +https://doi.org/10.6084/m9.figshare.29649986.v1
+
+# load data
+load("dat1.with.niches.norm.Robj")
+load("dat2.with.niches.norm.Robj")
+load("dat3.with.niches.norm.Robj")
+load("dat4.with.niches.norm.Robj")
+
+# Merge together
+merged_spatial <- merge(
+ dat1, y = c(dat2, dat3, dat4))
+
+# Set Default Assay to be "RNA"
+DefaultAssay(merged_spatial) <- "RNA"Compute score for Wnt, Notch, Hippo, Tgfb, and HIF-1a pathways for +the merged subject using ‘ComputeCellData’ in PathwayEmbed
+
+# Compute the score for each pathway
+Wnt_mds <- ComputeCellData(merged_spatial, "Wnt", "manhattan", batch.size = 1000)
+Notch_mds <- ComputeCellData(merged_spatial, "Notch", "manhattan", batch.size = 1000)
+Hippo_mds <- ComputeCellData(merged_spatial, "Hippo", "manhattan", batch.size = 1000)
+Tgfb_mds <- ComputeCellData(merged_spatial, "Tgfb", "manhattan", batch.size = 1000)
+HIF1a_mds <- ComputeCellData(merged_spatial, "HIF-1a", "manhattan", batch.size = 1000)
+
+# Process the mds
+Wnt_to.plot <- PreparePlotData(merged_spatial, Wnt_mds, "timepoint")
+Notch_to.plot <- PreparePlotData(merged_spatial, Notch_mds, "timepoint")
+Hippo_to.plot <- PreparePlotData(merged_spatial, Hippo_mds, "timepoint")
+Tgfb_to.plot <- PreparePlotData(merged_spatial, Tgfb_mds, "timepoint")
+HIF1a_to.plot <- PreparePlotData(merged_spatial, HIF1a_mds, "timepoint")
+
+# Combine to list
+pathway_list <- list(
+ Wnt = Wnt_to.plot,
+ Notch = Notch_to.plot,
+ Hippo = Hippo_to.plot,
+ Tgfb = Tgfb_to.plot,
+ HIF1a = HIF1a_to.plot
+)
+# Color set-up
+magma_colors <- c("#000004FF", "#721F81FF", "#F1605DFF", "#5A90E6")
+
+# Desired timepoint order
+ordered_timepoints <- c("E9.5", "E10.5", "E11.5", "E12.5")
+
+# Reorder timepoint levels
+for (name in names(pathway_list)) {
+ pathway_list[[name]]$timepoint <- factor(pathway_list[[name]]$timepoint, levels = ordered_timepoints)
+}
+# Loop through each pathway and generate/save the plot
+for (i in seq_along(pathway_list)) {
+ # Generate the plot
+ p <- PlotPathway(pathway_list[[i]], names(pathway_list)[i], "timepoint", magma_colors) +
+ facet_wrap(~timepoint, ncol = 1)
+ print(p)
+}




+# Step 1: Create named score vectors for each pathway
+score_list <- lapply(pathway_list, function(df) {
+ s <- df$scale
+ names(s) <- rownames(df)
+ return(s)
+})
+
+# Step 2: Add each pathway score to dat1–dat4
+for (i in 1:4) {
+ dat <- get(paste0("dat", i)) # get dat1, dat2, ...
+
+ for (pathway_name in names(score_list)) {
+ score_vec <- score_list[[pathway_name]]
+ dat[[paste0(pathway_name, "_score")]] <- score_vec[colnames(dat)]
+ }
+
+ assign(paste0("dat", i), dat) # assign back to dat1, dat2, etc.
+}
+
+
+# List of Seurat objects
+dat_list <- list(dat1, dat2, dat3, dat4)
+names(dat_list) <- paste0("dat", 1:4)
+
+# List of pathways
+pathways <- names(pathway_list) # e.g., "Wnt", "Notch", etc.
+# Function to extract
+extract_pathway_df <- function(seu, pathway, sample_name = "sample") {
+ coords <- as.data.frame(Embeddings(seu[["spatial"]]))
+ colnames(coords) <- c("x", "y")
+ coords$score <- seu[[paste0(pathway, "_score")]][rownames(coords), 1]
+ coords$sample <- sample_name
+ return(coords)
+}
+
+# Set list to save the coordinates
+combined_df_lists <- list()
+
+# For loop for all pathways
+for (pathway in pathways) {
+ pathway_df_list <- mapply(
+ FUN = extract_pathway_df,
+ seu = dat_list,
+ sample_name = names(dat_list),
+ MoreArgs = list(pathway = pathway),
+ SIMPLIFY = FALSE
+ )
+
+ combined_df <- do.call(rbind, pathway_df_list)
+ combined_df_lists[[pathway]] <- combined_df
+}
+limits_list <- list(
+ Wnt = c(-3, 4),
+ Notch = c(-3, 4),
+ Hippo = c(-2, 3),
+ Tgfb = c(-2, 3),
+ HIF1a = c(-3, 5)
+)
+
+for (pathway in names(combined_df_lists)) {
+ combined_df <- combined_df_lists[[pathway]]
+ selected_limits <- limits_list[[pathway]]
+
+ p <- ggplot(combined_df, aes(x = x, y = y, color = score)) +
+ geom_point(size = 0.3) +
+ scale_color_viridis_c(
+ option = "magma",
+ name = paste0(pathway, "_score"),
+ limits = selected_limits,
+ oob = scales::squish
+ ) +
+ scale_y_reverse() +
+ coord_fixed() +
+ theme_void() +
+ theme(legend.position = "right")
+
+ print(p)
+}




PathwayEmbed is an R package for quantifying and visualizing intracellular signaling pathway activation from transcriptomic data, integrating pathway topology and gene expression data.
+You can install the released version of PathwayEmbed from GitHub using:
+
+# Install remotes if you haven't already
+if (!requireNamespace("remotes", quietly = TRUE)) {
+ install.packages("remotes")
+}
+
+remotes::install_github("RaredonLab/PathwayEmbed")
+library(PathwayEmbed)
+
+# Load example data included with the package
+data(fake_test_object)
+
+# Compute pathway data
+mds_results <- ComputeCellData(fake_test_object, pathway = "Wnt", distance.method = "manhattan", batch.size = 100)
+
+# Prepare data for plotting
+plot_data <- PreparePlotData(fake_test_object, mds_results, group = "genotype")
+
+# Plot pathway activation
+PlotPathway(to.plot = plot_data, pathway = "Wnt", group = "genotype", color = c("#ae282c", "#2066a8"))
+
+# Calculate percentage and do comparison between two groups (optional)
+CalculatePercentage(to.plot = plot_data, group_var = "genotype")CalculatePercentage.RdThis function calculates the percentage of cells in ON (scale > 0) and OFF (scale < 0)
+activation states within each group defined by group_var. If exactly two groups
+are provided, it also computes Cohen's d effect size between their activation values.
CalculatePercentage(to.plot, group_var)A data frame with the percentage of ON/OFF cells and Cohen's d (if applicable).
+data(fake_to_plot)
+CalculatePercentage(fake_to_plot, "genotype")
+#> # A tibble: 2 × 4
+#> group percentage_on percentage_off cohens_d
+#> <chr> <dbl> <dbl> <dbl>
+#> 1 WT 9.6 90.4 -2.81
+#> 2 Mutant 98.4 1.6 -2.81
+ComputeCellData.RdA function computes cell status for a given pathway in single-cell RNA-seq data, +based on the distance between genes in a specified pathway. The distance is computed +for each batch of cells, and classical multidimensional scaling (MDS) is used to +visualize the pathway expression across cells.
+ComputeCellData(
+ x,
+ pathway,
+ distance.method,
+ batch.size = batch.size,
+ scale.data = TRUE
+)A Seurat object containing single-cell RNA sequencing data.
A character string specifying the pathway name. This should match a pathway used by LoadPathway().
A character string specifying the distance metric to use.Default is "manhattan".
+Options include: "manhattan", "euclidean", "canberra", "binary", "minkowski"
An integer specifying the number of cells to process per batch. Default is 1000.
A logical indicating whether to use scaled data (scale.data = TRUE) or normalized data. Default is TRUE.
A data frame of MDS results with normalized values per cell, suitable for thresholding or visualization.
+data(fake_test_object)
+ComputeCellData(fake_test_object, pathway = "Wnt", distance.method = "manhattan", batch.size = 2000)
+#> Centering and scaling data matrix
+#> Warning: The `slot` argument of `GetAssayData()` is deprecated as of SeuratObject 5.0.0.
+#> ℹ Please use the `layer` argument instead.
+#> ℹ The deprecated feature was likely used in the PathwayEmbed package.
+#> Please report the issue to the authors.
+#> Centering and scaling data matrix
+#> Processing batch 1
+#> Computing distance...
+#> Running MDS ...
+#> MDS finished
+#> Batch 1 processed with 2000 cells
+#> V1 normalized
+#> pathway.on 2.553664e+01 1.0000000
+#> pathway.off -1.385006e+02 0.0000000
+#> Cell1197 2.187651e+00 0.8576605
+#> Cell1431 2.977148e+00 0.8624734
+#> Cell460 -2.546460e+00 0.8288005
+#> Cell63 -3.237843e+00 0.8245857
+#> Cell485 -5.101010e+00 0.8132275
+#> Cell1894 3.336181e+00 0.8646621
+#> Cell1903 5.533059e+00 0.8780547
+#> Cell559 -4.417421e+00 0.8173948
+#> Cell927 -1.347230e-01 0.8435029
+#> Cell1476 4.472467e+00 0.8715891
+#> Cell1225 3.467462e+00 0.8654624
+#> Cell197 -5.139934e+00 0.8129902
+#> Cell517 -2.511700e+00 0.8290124
+#> Cell1791 1.478848e+00 0.8533395
+#> Cell536 -2.115078e+00 0.8314303
+#> Cell1871 4.390905e+00 0.8710919
+#> Cell77 -2.387543e-01 0.8428687
+#> Cell898 -2.657024e+00 0.8281265
+#> Cell446 -8.450933e-01 0.8391723
+#> Cell567 -2.598861e+00 0.8284811
+#> Cell1451 5.470021e+00 0.8776704
+#> Cell1086 2.239440e+00 0.8579762
+#> Cell555 -3.771045e+00 0.8213352
+#> Cell773 2.349337e+00 0.8586462
+#> Cell1493 1.409664e+01 0.9302598
+#> Cell1324 3.896961e+00 0.8680807
+#> Cell546 -4.931889e+00 0.8142585
+#> Cell70 -7.522571e+00 0.7984653
+#> Cell447 -1.107174e+00 0.8375747
+#> Cell1284 3.973831e+00 0.8685494
+#> Cell752 -1.746462e+00 0.8336774
+#> Cell674 -2.488876e+00 0.8291516
+#> Cell1699 6.279597e+00 0.8826057
+#> Cell1241 2.638256e+00 0.8604075
+#> Cell726 -6.072288e+00 0.8073065
+#> Cell1579 3.487952e+00 0.8655873
+#> Cell1927 2.706802e+00 0.8608253
+#> Cell1568 3.973536e+00 0.8685476
+#> Cell1094 4.435874e+00 0.8713660
+#> Cell265 -1.408844e+01 0.7584386
+#> Cell150 -6.804775e+00 0.8028411
+#> Cell1023 3.233407e+00 0.8640356
+#> Cell1290 7.713514e+00 0.8913471
+#> Cell1440 3.031405e+00 0.8628042
+#> Cell117 -1.495638e+00 0.8352065
+#> Cell930 -4.950148e+00 0.8141472
+#> Cell1553 6.111334e+00 0.8815799
+#> Cell180 -3.723328e+00 0.8216261
+#> Cell1208 8.361884e-01 0.8494217
+#> Cell22 -2.336217e+00 0.8300822
+#> Cell1631 1.757163e+00 0.8550362
+#> Cell1921 5.258278e+00 0.8763796
+#> Cell1962 1.972807e+00 0.8563508
+#> Cell1698 1.939627e+00 0.8561485
+#> Cell179 9.596402e-01 0.8501743
+#> Cell686 -3.143237e+00 0.8251625
+#> Cell833 -1.010920e+00 0.8381614
+#> Cell1561 3.923816e+00 0.8682445
+#> Cell495 -3.997717e+00 0.8199534
+#> Cell1522 4.194711e-02 0.8445799
+#> Cell165 3.482031e-02 0.8445365
+#> Cell264 -6.752699e+00 0.8031585
+#> Cell673 -5.718999e+00 0.8094602
+#> Cell736 -3.452739e+00 0.8232757
+#> Cell876 -4.843860e-02 0.8440289
+#> Cell1875 5.073292e+00 0.8752519
+#> Cell604 -1.655241e+00 0.8342335
+#> Cell1820 3.898603e+00 0.8680907
+#> Cell1840 1.570116e+00 0.8538959
+#> Cell1867 3.080942e+00 0.8631061
+#> Cell986 -1.910366e+00 0.8326783
+#> Cell1315 2.078346e+00 0.8569941
+#> Cell130 -8.159773e+00 0.7945808
+#> Cell1879 8.050219e+00 0.8933997
+#> Cell874 -5.906678e+00 0.8083160
+#> Cell643 -1.480603e+00 0.8352982
+#> Cell1830 -2.443915e+00 0.8294256
+#> Cell452 6.369148e-01 0.8482069
+#> Cell746 -5.608155e-01 0.8409054
+#> Cell577 -4.648033e+00 0.8159890
+#> Cell743 -4.132135e+00 0.8191340
+#> Cell902 -2.836086e+00 0.8270349
+#> Cell1686 4.337423e+00 0.8707659
+#> Cell1683 2.768362e+00 0.8612006
+#> Cell1017 3.014114e+00 0.8626988
+#> Cell1794 1.395343e+00 0.8528304
+#> Cell1856 4.937359e+00 0.8744232
+#> Cell1576 5.132836e+00 0.8756148
+#> Cell1217 4.591427e-01 0.8471232
+#> Cell156 -5.835136e+00 0.8087522
+#> Cell1479 3.519981e+00 0.8657826
+#> Cell1036 4.344174e+00 0.8708070
+#> Cell1462 3.681621e+00 0.8667680
+#> Cell1833 2.826915e+00 0.8615576
+#> Cell42 -7.133920e+00 0.8008346
+#> Cell1602 7.101675e+00 0.8876172
+#> Cell102 -2.228033e+00 0.8307417
+#> Cell1895 6.660881e+00 0.8849301
+#> Cell794 -4.007671e+00 0.8198927
+#> Cell828 -2.404265e+00 0.8296674
+#> Cell502 2.357721e+00 0.8586973
+#> Cell270 -6.929098e+00 0.8020832
+#> Cell1977 2.884556e+00 0.8619089
+#> Cell1511 3.600603e+00 0.8662741
+#> Cell1395 3.115589e+00 0.8633174
+#> Cell753 -1.058064e+01 0.7798228
+#> Cell869 -5.734909e+00 0.8093632
+#> Cell1809 4.959104e+00 0.8745557
+#> Cell13 -1.336615e+00 0.8361759
+#> Cell998 -3.556227e+00 0.8226448
+#> Cell1633 2.869601e+00 0.8618178
+#> Cell1441 4.315747e+00 0.8706337
+#> Cell589 -5.908401e+00 0.8083055
+#> Cell978 -8.250425e-01 0.8392946
+#> Cell288 -3.839366e+00 0.8209187
+#> Cell1989 1.791550e+00 0.8552458
+#> Cell823 -4.865908e+00 0.8146608
+#> Cell1547 3.497787e+00 0.8656473
+#> Cell1828 3.585430e+00 0.8661816
+#> Cell1287 3.720361e+00 0.8670042
+#> Cell1687 2.846559e+00 0.8616773
+#> Cell472 -2.709361e+00 0.8278074
+#> Cell1974 2.421795e+00 0.8590879
+#> Cell456 2.959891e+00 0.8623682
+#> Cell841 -4.193895e+00 0.8187575
+#> Cell1331 4.031491e+00 0.8689009
+#> Cell1385 4.675322e+00 0.8728258
+#> Cell955 -3.931901e+00 0.8203546
+#> Cell1702 2.685914e+00 0.8606980
+#> Cell877 -2.711916e+00 0.8277919
+#> Cell237 -3.690337e+00 0.8218272
+#> Cell537 -7.486860e+00 0.7986830
+#> Cell1845 1.927294e+00 0.8560733
+#> Cell1187 2.211473e+00 0.8578057
+#> Cell1069 2.830607e+00 0.8615801
+#> Cell210 -2.274699e+00 0.8304572
+#> Cell407 -3.318487e+00 0.8240941
+#> Cell1195 9.364764e+00 0.9014134
+#> Cell4 -3.185461e+00 0.8249051
+#> Cell418 -4.854738e+00 0.8147289
+#> Cell809 -5.900812e+00 0.8083518
+#> Cell82 -5.658418e+00 0.8098295
+#> Cell606 -5.761866e+00 0.8091988
+#> Cell1228 2.017230e+00 0.8566216
+#> Cell1935 3.575984e+00 0.8661240
+#> Cell384 -1.135996e-01 0.8436317
+#> Cell145 -3.842299e+00 0.8209009
+#> Cell1738 5.516290e+00 0.8779525
+#> Cell748 -4.278771e+00 0.8182400
+#> Cell269 -3.404980e+00 0.8235668
+#> Cell432 -2.566191e+00 0.8286802
+#> Cell1831 4.375985e+00 0.8710010
+#> Cell1237 3.100348e+00 0.8632244
+#> Cell1508 5.196014e+00 0.8760000
+#> Cell1729 1.053436e+00 0.8507461
+#> Cell1539 5.923649e+00 0.8804358
+#> Cell1799 3.653703e+00 0.8665978
+#> Cell689 -1.154593e+00 0.8372856
+#> Cell198 -1.845843e+00 0.8330716
+#> Cell1499 4.025919e+00 0.8688669
+#> Cell1292 4.396208e+00 0.8711242
+#> Cell295 -1.396820e+00 0.8358089
+#> Cell395 -4.903640e+00 0.8144307
+#> Cell1906 5.587828e+00 0.8783886
+#> Cell40 -4.673462e+00 0.8158339
+#> Cell758 -4.774790e+00 0.8152162
+#> Cell113 -4.088663e+00 0.8193990
+#> Cell492 -1.099543e+00 0.8376212
+#> Cell1268 1.981964e+00 0.8564066
+#> Cell527 -6.433225e+00 0.8051061
+#> Cell1490 2.941128e+00 0.8622538
+#> Cell812 -4.116034e+00 0.8192321
+#> Cell950 -3.879478e+00 0.8206742
+#> Cell597 2.877903e-01 0.8460786
+#> Cell826 -4.623204e+00 0.8161403
+#> Cell1053 4.239387e+00 0.8701682
+#> Cell484 -2.890247e+00 0.8267047
+#> Cell1005 5.166262e+00 0.8758186
+#> Cell614 -1.422096e-01 0.8434572
+#> Cell1166 2.632685e+00 0.8603735
+#> Cell834 -3.667927e+00 0.8219639
+#> Cell1916 2.767592e+00 0.8611959
+#> Cell453 5.858527e-02 0.8446813
+#> Cell1924 6.397852e+00 0.8833266
+#> Cell549 1.917411e-01 0.8454931
+#> Cell364 -3.557349e+00 0.8226380
+#> Cell644 -2.377471e+00 0.8298307
+#> Cell56 -4.258388e+00 0.8183643
+#> Cell1332 3.549074e+00 0.8659600
+#> Cell697 -5.651913e+00 0.8098691
+#> Cell1681 5.007297e+00 0.8748495
+#> Cell1495 3.037721e+00 0.8628427
+#> Cell543 -3.521890e+00 0.8228541
+#> Cell477 -8.262690e-01 0.8392871
+#> Cell1716 3.509726e+00 0.8657201
+#> Cell458 -3.216938e+00 0.8247132
+#> Cell24 -4.355618e+00 0.8177716
+#> Cell951 -4.708977e+00 0.8156174
+#> Cell969 -4.185427e+00 0.8188091
+#> Cell1792 3.923161e+00 0.8682405
+#> Cell601 -3.824720e+00 0.8210080
+#> Cell1546 6.873521e-01 0.8485144
+#> Cell1876 2.297689e+00 0.8583313
+#> Cell723 -3.242268e+00 0.8245588
+#> Cell857 -3.880601e+00 0.8206674
+#> Cell1203 3.828079e+00 0.8676608
+#> Cell541 -1.570782e+00 0.8347484
+#> Cell49 -2.564633e+00 0.8286897
+#> Cell1103 2.058576e+00 0.8568736
+#> Cell703 -3.201709e+00 0.8248060
+#> Cell953 -4.987646e+00 0.8139186
+#> Cell1808 2.902630e+00 0.8620191
+#> Cell1873 6.854803e+00 0.8861123
+#> Cell971 3.630673e-01 0.8465375
+#> Cell1519 4.697006e+00 0.8729580
+#> Cell310 -1.391486e+00 0.8358414
+#> Cell1836 6.476657e+00 0.8838070
+#> Cell956 -6.024846e+00 0.8075957
+#> Cell1159 1.935235e+00 0.8561217
+#> Cell691 -5.382385e+00 0.8115122
+#> Cell1116 2.366846e+00 0.8587529
+#> Cell1128 5.978390e+00 0.8807695
+#> Cell771 -1.004896e+00 0.8381982
+#> Cell1424 3.092833e+00 0.8631786
+#> Cell584 -6.808329e+00 0.8028194
+#> Cell396 -3.655225e+00 0.8220413
+#> Cell760 -1.197136e+00 0.8370262
+#> Cell1346 2.423370e-01 0.8458015
+#> Cell583 -4.992521e+00 0.8138889
+#> Cell722 -6.643534e+00 0.8038240
+#> Cell538 -4.484421e+00 0.8169864
+#> Cell832 -1.092899e+01 0.7776992
+#> Cell1404 3.778424e+00 0.8673581
+#> Cell1889 1.968310e+00 0.8563233
+#> Cell1141 4.331806e+00 0.8707316
+#> Cell1242 5.920307e+00 0.8804154
+#> Cell1983 6.504761e+00 0.8839783
+#> Cell57 -2.356628e+00 0.8299578
+#> Cell43 -1.665190e+00 0.8341729
+#> Cell1313 -1.398594e+00 0.8357981
+#> Cell528 5.504613e-01 0.8476799
+#> Cell87 1.443877e-01 0.8452044
+#> Cell1020 2.450118e+00 0.8592605
+#> Cell143 -3.802415e+00 0.8211440
+#> Cell875 -5.022787e+00 0.8137044
+#> Cell1056 4.792765e+00 0.8735417
+#> Cell212 -3.941065e+00 0.8202988
+#> Cell1243 2.913179e+00 0.8620834
+#> Cell1949 5.004021e+00 0.8748296
+#> Cell572 -2.332036e+00 0.8301077
+#> Cell793 -5.820650e+00 0.8088405
+#> Cell1661 2.551152e+00 0.8598765
+#> Cell138 -8.311082e-01 0.8392576
+#> Cell1978 6.962061e+00 0.8867661
+#> Cell884 -1.040785e+00 0.8379794
+#> Cell1391 2.796244e+00 0.8613706
+#> Cell1084 3.509317e+00 0.8657176
+#> Cell1997 3.814125e+00 0.8675758
+#> Cell1466 1.497821e+00 0.8534552
+#> Cell702 -3.037891e+00 0.8258047
+#> Cell1570 4.885413e+00 0.8741065
+#> Cell762 -8.678231e+00 0.7914202
+#> Cell1837 4.501838e+00 0.8717682
+#> Cell306 -1.653314e+00 0.8342453
+#> Cell421 -5.784453e+00 0.8090611
+#> Cell19 -1.838534e+00 0.8331162
+#> Cell596 -4.342032e-01 0.8416772
+#> Cell206 -7.439508e+00 0.7989716
+#> Cell98 1.471492e-02 0.8444139
+#> Cell646 -5.856347e+00 0.8086229
+#> Cell1075 5.444444e+00 0.8775145
+#> Cell1137 3.098294e+00 0.8632119
+#> Cell984 -3.434539e+00 0.8233866
+#> Cell168 -7.060415e+00 0.8012827
+#> Cell734 -4.230782e+00 0.8185326
+#> Cell470 -1.666421e+00 0.8341654
+#> Cell968 -2.321066e+00 0.8301746
+#> Cell654 2.377754e-01 0.8457737
+#> Cell512 -8.234125e+00 0.7941275
+#> Cell67 -6.091040e+00 0.8071921
+#> Cell18 -4.235923e+00 0.8185013
+#> Cell1007 3.175780e+00 0.8636843
+#> Cell399 -5.438964e+00 0.8111673
+#> Cell1780 2.640760e+00 0.8604227
+#> Cell928 -2.648884e+00 0.8281761
+#> Cell124 -4.866034e+00 0.8146600
+#> Cell1986 2.029917e+00 0.8566989
+#> Cell679 -6.261440e+00 0.8061533
+#> Cell309 -1.806025e+00 0.8333143
+#> Cell840 -4.835286e+00 0.8148474
+#> Cell239 -1.063424e+01 0.7794960
+#> Cell1189 5.023362e+00 0.8749475
+#> Cell656 -2.560149e-01 0.8427635
+#> Cell1587 9.429585e-01 0.8500726
+#> Cell356 -6.475996e-01 0.8403763
+#> Cell929 -9.602209e-02 0.8437388
+#> Cell1049 2.646391e+00 0.8604570
+#> Cell1870 3.617627e+00 0.8663779
+#> Cell1111 4.923236e+00 0.8743371
+#> Cell973 -3.095113e+00 0.8254558
+#> Cell819 -1.361698e+00 0.8360230
+#> Cell1311 3.189516e+00 0.8637680
+#> Cell666 -7.208716e+00 0.8003786
+#> Cell1272 5.116513e+00 0.8755153
+#> Cell1411 6.102751e+00 0.8815276
+#> Cell1854 5.331844e+00 0.8768280
+#> Cell575 -1.013407e+00 0.8381463
+#> Cell289 -3.440123e+00 0.8233526
+#> Cell1513 2.163586e+00 0.8575138
+#> Cell48 -2.005106e+00 0.8321007
+#> Cell1258 2.951004e+00 0.8623140
+#> Cell1976 4.420621e+00 0.8712731
+#> Cell402 -8.028658e+00 0.7953801
+#> Cell1514 5.461089e+00 0.8776159
+#> Cell347 -4.785454e+00 0.8151512
+#> Cell1176 4.157537e+00 0.8696693
+#> Cell482 -1.688151e+00 0.8340329
+#> Cell1236 5.147822e-02 0.8446380
+#> Cell325 -1.676620e+00 0.8341032
+#> Cell1406 5.643447e+00 0.8787276
+#> Cell1164 2.663221e+00 0.8605596
+#> Cell684 -4.317017e+00 0.8180069
+#> Cell1559 3.963602e+00 0.8684870
+#> Cell493 -2.003234e+00 0.8321121
+#> Cell52 -1.284233e+00 0.8364953
+#> Cell1028 5.046281e+00 0.8750872
+#> Cell339 -4.157261e+00 0.8189808
+#> Cell127 1.009588e+00 0.8504788
+#> Cell1689 8.364138e+00 0.8953134
+#> Cell662 -6.814474e+00 0.8027820
+#> Cell533 -8.081572e+00 0.7950575
+#> Cell240 -4.852682e+00 0.8147414
+#> Cell83 -4.606531e+00 0.8162420
+#> Cell1276 2.864829e+00 0.8617887
+#> Cell142 -2.087740e+00 0.8315970
+#> Cell796 -6.795746e+00 0.8028961
+#> Cell1734 2.247683e+00 0.8580264
+#> Cell1022 4.698736e+00 0.8729685
+#> Cell838 -1.201654e+01 0.7710693
+#> Cell1673 1.439939e+00 0.8531023
+#> Cell7 -4.512267e+00 0.8168166
+#> Cell1782 7.481669e+00 0.8899337
+#> Cell506 1.828282e+00 0.8554697
+#> Cell6 -3.214697e+00 0.8247268
+#> Cell389 -6.606362e+00 0.8040506
+#> Cell1548 2.498213e+00 0.8595537
+#> Cell1939 2.997972e+00 0.8626003
+#> Cell1419 4.320444e+00 0.8706624
+#> Cell32 -2.615157e+00 0.8283817
+#> Cell1777 2.777922e+00 0.8612589
+#> Cell587 -4.069732e+00 0.8195144
+#> Cell1805 4.640862e+00 0.8726157
+#> Cell1163 4.807844e+00 0.8736336
+#> Cell8 -3.045980e-01 0.8424673
+#> Cell1771 1.686082e+00 0.8546028
+#> Cell1725 4.684973e+00 0.8728846
+#> Cell1398 2.880267e+00 0.8618828
+#> Cell1818 4.941171e+00 0.8744464
+#> Cell1801 1.995808e+00 0.8564910
+#> Cell1885 3.339474e+00 0.8646822
+#> Cell668 4.519370e-01 0.8470793
+#> Cell1680 3.586560e+00 0.8661885
+#> Cell473 -1.812677e+00 0.8332738
+#> Cell1309 1.008637e+00 0.8504730
+#> Cell28 -1.225058e+00 0.8368560
+#> Cell721 -1.009088e+00 0.8381726
+#> Cell97 7.193237e+00 0.8881754
+#> Cell873 -1.445274e+00 0.8355135
+#> Cell1280 5.396265e+00 0.8772208
+#> Cell1618 4.846298e+00 0.8738681
+#> Cell304 3.755606e-01 0.8466137
+#> Cell1810 3.412701e+00 0.8651286
+#> Cell1504 4.774666e+00 0.8734314
+#> Cell151 -5.723791e-01 0.8408349
+#> Cell192 -6.907142e+00 0.8022170
+#> Cell1653 2.983145e+00 0.8625100
+#> Cell1770 3.472923e+00 0.8654957
+#> Cell391 -2.187685e+00 0.8309877
+#> Cell1222 1.350106e+00 0.8525547
+#> Cell149 -5.999439e+00 0.8077506
+#> Cell553 -3.467409e+00 0.8231863
+#> Cell1590 6.228099e+00 0.8822918
+#> Cell317 -7.354865e+00 0.7994876
+#> Cell1728 6.403440e+00 0.8833607
+#> Cell1741 3.331638e+00 0.8646344
+#> Cell639 -4.620982e+00 0.8161539
+#> Cell931 -2.394116e+00 0.8297292
+#> Cell1998 2.131249e+00 0.8573166
+#> Cell1844 4.018112e+00 0.8688193
+#> Cell1536 2.599281e+00 0.8601699
+#> Cell74 -2.644634e+00 0.8282020
+#> Cell316 -3.112156e+00 0.8253519
+#> Cell1051 3.635022e+00 0.8664839
+#> Cell802 -1.272071e+00 0.8365694
+#> Cell1194 4.550709e+00 0.8720661
+#> Cell183 1.387707e+00 0.8527839
+#> Cell820 -6.764886e+00 0.8030843
+#> Cell1068 4.821785e+00 0.8737186
+#> Cell540 -3.718339e+00 0.8216565
+#> Cell624 -8.942328e+00 0.7898102
+#> Cell375 -3.199804e+00 0.8248176
+#> Cell706 -2.085771e+00 0.8316090
+#> Cell713 8.168414e-01 0.8493038
+#> Cell1853 3.784067e+00 0.8673925
+#> Cell908 -7.641382e+00 0.7977410
+#> Cell1657 2.334848e+00 0.8585578
+#> Cell1866 2.761910e+00 0.8611613
+#> Cell58 -1.972285e+00 0.8323008
+#> Cell738 -3.995293e+00 0.8199682
+#> Cell1474 5.709286e+00 0.8791290
+#> Cell17 -2.350681e+00 0.8299940
+#> Cell737 -3.845859e-01 0.8419797
+#> Cell825 7.712981e-01 0.8490262
+#> Cell754 -3.049089e+00 0.8257364
+#> Cell1929 -4.290028e-02 0.8440627
+#> Cell16 -5.797645e+00 0.8089807
+#> Cell1375 3.475647e+00 0.8655123
+#> Cell41 -5.962514e+00 0.8079757
+#> Cell524 -1.781798e+00 0.8334620
+#> Cell957 -4.127493e+00 0.8191623
+#> Cell397 -2.791428e+00 0.8273071
+#> Cell1758 1.074573e+00 0.8508750
+#> Cell357 -4.872778e-01 0.8413537
+#> Cell1352 2.551763e+00 0.8598802
+#> Cell870 -1.415433e+00 0.8356955
+#> Cell699 -6.860772e+00 0.8024997
+#> Cell1085 5.519276e+00 0.8779707
+#> Cell897 -7.292057e+00 0.7998705
+#> Cell1428 4.569223e+00 0.8721790
+#> Cell682 -1.561916e+01 0.7491070
+#> Cell1443 3.178557e+00 0.8637012
+#> Cell1859 5.283790e+00 0.8765351
+#> Cell551 2.604872e-02 0.8444830
+#> Cell14 -4.966252e-01 0.8412967
+#> Cell1922 2.890512e+00 0.8619453
+#> Cell938 -3.253830e+00 0.8244883
+#> Cell1231 3.786001e+00 0.8674043
+#> Cell1314 3.080107e+00 0.8631011
+#> Cell1557 3.964399e+00 0.8684919
+#> Cell1030 7.450965e+00 0.8897466
+#> Cell383 -1.768409e-01 0.8432461
+#> Cell1910 6.028404e+00 0.8810744
+#> Cell483 -4.774797e+00 0.8152162
+#> Cell548 -2.900027e+00 0.8266451
+#> Cell1379 2.306977e+00 0.8583879
+#> Cell1254 1.907233e+00 0.8559510
+#> Cell1060 4.870654e+00 0.8740165
+#> Cell1649 3.548654e+00 0.8659574
+#> Cell1328 6.043101e+00 0.8811640
+#> Cell263 -4.529245e+00 0.8167131
+#> Cell203 2.743575e-01 0.8459967
+#> Cell496 -7.002914e+00 0.8016332
+#> Cell1485 6.179335e+00 0.8819945
+#> Cell1417 5.472083e-01 0.8476601
+#> Cell1679 9.559373e+00 0.9025998
+#> Cell878 -1.618421e+00 0.8344580
+#> Cell1202 1.969329e+00 0.8563296
+#> Cell778 -2.628158e+00 0.8283025
+#> Cell637 -1.180423e+00 0.8371281
+#> Cell109 -2.055887e+00 0.8317911
+#> Cell1038 3.944102e+00 0.8683681
+#> Cell1165 1.030655e+00 0.8506072
+#> Cell619 -1.084056e+00 0.8377156
+#> Cell1748 4.196021e+00 0.8699039
+#> Cell261 -4.153012e+00 0.8190067
+#> Cell672 -5.776461e+00 0.8091099
+#> Cell1625 4.033235e+00 0.8689115
+#> Cell71 -1.661454e+00 0.8341957
+#> Cell965 -4.822146e-02 0.8440302
+#> Cell1339 3.911760e+00 0.8681710
+#> Cell1663 5.278787e+00 0.8765046
+#> Cell1662 1.879105e+00 0.8557795
+#> Cell882 -1.881731e+00 0.8328528
+#> Cell1603 5.001504e+00 0.8748142
+#> Cell207 -3.414599e+00 0.8235082
+#> Cell1665 3.382918e+00 0.8649470
+#> Cell69 -1.078374e+01 0.7785846
+#> Cell1037 1.628652e+00 0.8542527
+#> Cell321 -5.952138e+00 0.8080389
+#> Cell725 -2.634715e+00 0.8282625
+#> Cell1715 1.125425e+00 0.8511850
+#> Cell922 -5.324164e+00 0.8118671
+#> Cell260 -2.855633e+00 0.8269157
+#> Cell1035 3.441518e+00 0.8653043
+#> Cell1652 4.532720e+00 0.8719564
+#> Cell1262 5.147296e+00 0.8757030
+#> Cell1494 3.751850e+00 0.8671961
+#> Cell96 -5.454876e+00 0.8110703
+#> Cell1011 6.063291e+00 0.8812871
+#> Cell1185 3.646979e+00 0.8665568
+#> Cell1376 3.932055e+00 0.8682947
+#> Cell37 -8.800870e-01 0.8389590
+#> Cell1113 6.667043e+00 0.8849676
+#> Cell1044 3.470057e+00 0.8654783
+#> Cell457 -4.922316e+00 0.8143169
+#> Cell1002 4.523969e+00 0.8719031
+#> Cell1273 1.586153e+00 0.8539936
+#> Cell449 -7.574314e-01 0.8397067
+#> Cell568 -4.627982e+00 0.8161112
+#> Cell406 -5.014503e+00 0.8137549
+#> Cell394 -1.037620e-01 0.8436916
+#> Cell1286 6.978705e+00 0.8868676
+#> Cell1647 4.868471e+00 0.8740032
+#> Cell1778 2.070510e+00 0.8569464
+#> Cell944 8.343017e-01 0.8494102
+#> Cell1869 3.000674e+00 0.8626168
+#> Cell157 -3.143330e+00 0.8251619
+#> Cell1902 3.403933e+00 0.8650752
+#> Cell1041 5.848269e+00 0.8799763
+#> Cell558 -3.158195e+00 0.8250713
+#> Cell982 -2.161525e+00 0.8311471
+#> Cell390 -5.048260e+00 0.8135491
+#> Cell913 -4.612035e+00 0.8162084
+#> Cell171 -2.998081e+00 0.8260474
+#> Cell1123 6.083251e+00 0.8814087
+#> Cell1912 5.827573e+00 0.8798501
+#> Cell1019 3.476952e+00 0.8655203
+#> Cell414 -8.182012e+00 0.7944452
+#> Cell1765 5.540452e+00 0.8780997
+#> Cell1058 1.602222e+00 0.8540916
+#> Cell45 -5.352631e+00 0.8116936
+#> Cell712 -1.050753e+01 0.7802685
+#> Cell810 -5.558811e+00 0.8104367
+#> Cell570 -3.217922e+00 0.8247072
+#> Cell464 -5.695609e+00 0.8096028
+#> Cell1265 3.423275e+00 0.8651931
+#> Cell100 -2.825999e+00 0.8270964
+#> Cell1886 3.725250e+00 0.8670340
+#> Cell1985 4.174432e+00 0.8697723
+#> Cell1574 5.900179e+00 0.8802927
+#> Cell290 -6.467836e+00 0.8048951
+#> Cell1544 3.996915e+00 0.8686901
+#> Cell209 -5.794884e+00 0.8089976
+#> Cell632 -3.043693e+00 0.8257693
+#> Cell941 -8.557644e+00 0.7921553
+#> Cell1102 4.412787e+00 0.8712253
+#> Cell1335 2.238093e+00 0.8579680
+#> Cell1656 2.655235e+00 0.8605110
+#> Cell818 -4.657222e+00 0.8159329
+#> Cell1338 7.100034e+00 0.8876072
+#> Cell893 2.010079e-01 0.8455496
+#> Cell1527 1.242014e+00 0.8518957
+#> Cell519 -5.789332e-01 0.8407949
+#> Cell1178 2.457754e+00 0.8593071
+#> Cell626 -3.901159e+00 0.8205420
+#> Cell763 -4.302723e+00 0.8180940
+#> Cell1861 3.946411e+00 0.8683822
+#> Cell952 -1.434508e+00 0.8355792
+#> Cell1003 3.231105e+00 0.8640216
+#> Cell488 -1.920005e+00 0.8326195
+#> Cell136 -3.074668e+00 0.8255805
+#> Cell1934 2.884439e+00 0.8619082
+#> Cell1750 5.260675e+00 0.8763942
+#> Cell1675 5.536263e+00 0.8780742
+#> Cell901 -6.761272e+00 0.8031063
+#> Cell255 -6.715197e+00 0.8033872
+#> Cell648 -4.410303e+00 0.8174382
+#> Cell926 -5.424037e+00 0.8112583
+#> Cell757 -9.442342e+00 0.7867620
+#> Cell413 -3.506912e+00 0.8229454
+#> Cell920 -3.197806e+00 0.8248298
+#> Cell1247 5.830726e+00 0.8798693
+#> Cell205 -7.265008e+00 0.8000354
+#> Cell1824 3.844376e+00 0.8677602
+#> Cell1654 4.096881e+00 0.8692995
+#> Cell719 -6.068007e+00 0.8073325
+#> Cell822 -2.336410e+00 0.8300810
+#> Cell683 -8.943098e+00 0.7898055
+#> Cell73 -1.517182e+00 0.8350752
+#> Cell967 -3.683881e+00 0.8218666
+#> Cell839 -7.451148e+00 0.7989007
+#> Cell1612 3.825035e+00 0.8676423
+#> Cell1469 5.711182e+00 0.8791405
+#> Cell84 -3.900975e+00 0.8205432
+#> Cell1832 5.534668e+00 0.8780645
+#> Cell110 -3.841740e-01 0.8419822
+#> Cell1874 3.101146e+00 0.8632293
+#> Cell1204 2.628265e+00 0.8603465
+#> Cell815 -5.942406e+00 0.8080982
+#> Cell455 -1.473736e+00 0.8353400
+#> Cell1210 1.988901e+00 0.8564489
+#> Cell242 -5.079950e+00 0.8133559
+#> Cell987 -4.694071e+00 0.8157083
+#> Cell853 -8.193048e+00 0.7943779
+#> Cell194 3.925843e-01 0.8467174
+#> Cell856 -5.914379e+00 0.8082691
+#> Cell5 -9.328239e+00 0.7874576
+#> Cell1275 2.687362e+00 0.8607068
+#> Cell308 5.872523e-01 0.8479042
+#> Cell1629 6.003907e+00 0.8809251
+#> Cell867 -4.026943e+00 0.8197752
+#> Cell388 -2.395782e+00 0.8297191
+#> Cell1377 3.954077e+00 0.8684289
+#> Cell1761 2.378838e+00 0.8588260
+#> Cell181 -1.023301e+01 0.7819420
+#> Cell86 -2.358342e-01 0.8428865
+#> Cell442 8.118318e-01 0.8492733
+#> Cell509 -5.880644e+00 0.8084747
+#> Cell1043 2.196907e+00 0.8577169
+#> Cell616 -1.966782e+00 0.8323343
+#> Cell1047 7.471541e-01 0.8488790
+#> Cell381 8.123613e-01 0.8492765
+#> Cell177 -5.459928e+00 0.8110395
+#> Cell1860 4.646909e+00 0.8726526
+#> Cell330 -6.317148e+00 0.8058137
+#> Cell1575 5.870997e+00 0.8801148
+#> Cell797 6.539766e-01 0.8483109
+#> Cell1355 4.091853e+00 0.8692688
+#> Cell148 -5.132085e+00 0.8130381
+#> Cell792 3.512972e-01 0.8464658
+#> Cell1678 1.040851e+00 0.8506694
+#> Cell997 -5.141204e-01 0.8411900
+#> Cell1767 6.300441e+00 0.8827328
+#> Cell1357 3.756377e+00 0.8672237
+#> Cell1581 3.557354e+00 0.8660104
+#> Cell320 -9.302799e-01 0.8386530
+#> Cell1747 4.217434e+00 0.8700344
+#> Cell1693 4.442914e+00 0.8714090
+#> Cell1666 6.511467e+00 0.8840192
+#> Cell798 -5.282589e+00 0.8121206
+#> Cell478 5.231596e+00 0.8762169
+#> Cell1620 2.677388e-01 0.8459564
+#> Cell594 -2.657657e+00 0.8281226
+#> Cell27 -4.733011e+00 0.8154709
+#> Cell660 -5.533604e+00 0.8105904
+#> Cell1524 7.513489e+00 0.8901277
+#> Cell417 -3.302960e+00 0.8241888
+#> Cell623 -4.829405e+00 0.8148833
+#> Cell1363 3.284126e+00 0.8643448
+#> Cell985 1.443609e+00 0.8531247
+#> Cell692 -3.653688e+00 0.8220507
+#> Cell355 -6.682579e+00 0.8035860
+#> Cell1345 2.035759e+00 0.8567345
+#> Cell1645 6.078817e+00 0.8813817
+#> Cell909 -1.281301e+00 0.8365131
+#> Cell1198 -2.433871e-02 0.8441758
+#> Cell545 -7.284642e+00 0.7999157
+#> Cell199 -1.413354e+00 0.8357081
+#> Cell480 -5.120715e+00 0.8131074
+#> Cell756 -6.979196e+00 0.8017778
+#> Cell311 -2.019316e+00 0.8320141
+#> Cell465 -1.420365e+00 0.8356654
+#> Cell727 -5.776192e+00 0.8091115
+#> Cell1911 4.691621e+00 0.8729251
+#> Cell814 -7.718218e+00 0.7972726
+#> Cell1319 -1.620753e-01 0.8433361
+#> Cell910 -4.453910e+00 0.8171724
+#> Cell223 -9.335405e-01 0.8386332
+#> Cell35 -5.605460e+00 0.8101523
+#> Cell1969 2.163836e+00 0.8575153
+#> Cell1951 2.112293e+00 0.8572011
+#> Cell1815 3.054876e+00 0.8629472
+#> Cell116 -6.671553e+00 0.8036532
+#> Cell868 -4.173768e+00 0.8188802
+#> Cell1650 6.068290e+00 0.8813175
+#> Cell1063 7.740373e-02 0.8447960
+#> Cell1994 5.836096e-01 0.8478820
+#> Cell494 -1.026005e+00 0.8380695
+#> Cell779 -5.609981e+00 0.8101248
+#> Cell507 -2.010882e+00 0.8320655
+#> Cell118 -4.142007e+00 0.8190738
+#> Cell1537 3.854534e+00 0.8678221
+#> Cell1609 4.262184e+00 0.8703072
+#> Cell1764 1.165758e+00 0.8514308
+#> Cell1847 6.175221e+00 0.8819694
+#> Cell1161 3.460194e+00 0.8654181
+#> Cell881 -4.081652e+00 0.8194417
+#> Cell1291 3.124824e+00 0.8633737
+#> Cell1281 1.556338e+00 0.8538119
+#> Cell1299 5.007457e+00 0.8748505
+#> Cell163 9.846166e-01 0.8503266
+#> Cell377 -2.669592e+00 0.8280499
+#> Cell104 -5.555989e+00 0.8104539
+#> Cell227 -2.399824e+00 0.8296944
+#> Cell1703 1.786450e+00 0.8552147
+#> Cell1365 1.299195e+00 0.8522443
+#> Cell1585 5.450907e+00 0.8775539
+#> Cell1249 2.122743e+00 0.8572648
+#> Cell475 -5.108411e+00 0.8131824
+#> Cell590 -1.310648e+00 0.8363342
+#> Cell1913 1.509220e-01 0.8452442
+#> Cell1477 1.993907e+00 0.8564794
+#> Cell114 -4.406950e+00 0.8174586
+#> Cell268 -1.152648e+01 0.7740567
+#> Cell348 -5.346972e+00 0.8117281
+#> Cell38 -4.802610e+00 0.8150466
+#> Cell324 1.086231e+00 0.8509460
+#> Cell1372 4.379912e+00 0.8710249
+#> Cell108 -8.473637e+00 0.7926674
+#> Cell768 9.972445e-01 0.8504036
+#> Cell914 -1.350892e+00 0.8360889
+#> Cell1410 2.791400e+00 0.8613410
+#> Cell602 -2.460270e+00 0.8293259
+#> Cell1070 2.428663e+00 0.8591297
+#> Cell1564 2.278426e+00 0.8582139
+#> Cell15 7.904911e-01 0.8491432
+#> Cell653 -3.546062e+00 0.8227068
+#> Cell1982 9.046943e-01 0.8498394
+#> Cell448 -3.801550e+00 0.8211493
+#> Cell26 -1.347845e+00 0.8361075
+#> Cell1397 3.394335e+00 0.8650166
+#> Cell1838 5.675577e+00 0.8789235
+#> Cell224 -2.657126e+00 0.8281259
+#> Cell954 -5.597396e+00 0.8102015
+#> Cell1940 5.301888e+00 0.8766454
+#> Cell1754 2.295328e+00 0.8583169
+#> Cell1534 3.129269e+00 0.8634008
+#> Cell962 -1.098184e+00 0.8376295
+#> Cell1814 5.328388e+00 0.8768070
+#> Cell1807 9.605482e-02 0.8449097
+#> Cell1122 2.808429e+00 0.8614449
+#> Cell714 -3.794824e+00 0.8211903
+#> Cell1604 4.217865e+00 0.8700370
+#> Cell891 -9.507693e+00 0.7863636
+#> Cell688 -2.407078e+00 0.8296502
+#> Cell824 -6.831062e-01 0.8401598
+#> Cell1378 3.167292e+00 0.8636325
+#> Cell211 -6.258159e+00 0.8061734
+#> Cell278 -4.518571e+00 0.8167782
+#> Cell345 -5.556628e+00 0.8104500
+#> Cell700 -7.229416e+00 0.8002524
+#> Cell1183 3.660341e+00 0.8666383
+#> Cell1724 4.570305e+00 0.8721856
+#> Cell851 -3.752316e+00 0.8214494
+#> Cell991 -5.035866e+00 0.8136247
+#> Cell1215 1.445845e+00 0.8531383
+#> Cell474 -7.600605e+00 0.7979896
+#> Cell94 -2.922875e+00 0.8265058
+#> Cell650 -6.759905e+00 0.8031146
+#> Cell1131 3.575456e+00 0.8661208
+#> Cell627 -1.502394e+00 0.8351653
+#> Cell408 -5.784622e+00 0.8090601
+#> Cell196 -5.580251e+00 0.8103060
+#> Cell129 -1.184406e+01 0.7721207
+#> Cell615 -4.386851e+00 0.8175812
+#> Cell1923 3.849343e+00 0.8677905
+#> Cell911 -4.425448e+00 0.8173459
+#> Cell1330 4.440676e+00 0.8713953
+#> Cell46 -2.265883e-01 0.8429429
+#> Cell1952 1.344951e+00 0.8525232
+#> Cell1230 3.976275e+00 0.8685642
+#> Cell1079 2.395342e+00 0.8589266
+#> Cell942 4.361286e-01 0.8469829
+#> Cell907 -3.957330e+00 0.8201996
+#> Cell1087 2.476128e+00 0.8594191
+#> Cell1623 4.864560e+00 0.8739794
+#> Cell170 -7.342755e+00 0.7995615
+#> Cell51 -8.688829e+00 0.7913556
+#> Cell1882 2.492005e+00 0.8595159
+#> Cell1154 2.090085e+00 0.8570657
+#> Cell191 -4.651418e+00 0.8159683
+#> Cell476 -4.177008e+00 0.8188604
+#> Cell60 2.145432e+00 0.8574031
+#> Cell1930 2.855350e+00 0.8617309
+#> Cell184 -5.738340e+00 0.8093423
+#> Cell1327 3.327687e-01 0.8463528
+#> Cell593 -7.251074e+00 0.8001204
+#> Cell1904 2.783402e+00 0.8612923
+#> Cell1802 5.245143e+00 0.8762995
+#> Cell166 -5.634599e+00 0.8099747
+#> Cell1308 1.752834e+00 0.8550098
+#> Cell1461 2.964834e+00 0.8623983
+#> Cell580 -2.048649e+00 0.8318353
+#> Cell1112 3.980903e+00 0.8685925
+#> Cell1907 6.688858e+00 0.8851006
+#> Cell1909 3.797072e+00 0.8674718
+#> Cell1627 5.130337e+00 0.8755996
+#> Cell1407 5.980624e+00 0.8807831
+#> Cell1221 6.697669e+00 0.8851543
+#> Cell1601 2.797246e+00 0.8613767
+#> Cell1232 2.557335e+00 0.8599141
+#> Cell1787 3.088024e+00 0.8631493
+#> Cell1093 3.998314e+00 0.8686986
+#> Cell993 -4.008546e+00 0.8198874
+#> Cell1224 2.684645e+00 0.8606902
+#> Cell1488 2.123955e+00 0.8572722
+#> Cell154 -8.072250e-01 0.8394032
+#> Cell1074 2.347111e+00 0.8586326
+#> Cell1980 4.728022e+00 0.8731470
+#> Cell208 -4.474562e+00 0.8170465
+#> Cell1706 3.245238e+00 0.8641077
+#> Cell1712 1.904389e+00 0.8559337
+#> Cell343 -2.900192e+00 0.8266441
+#> Cell1400 4.581764e+00 0.8722554
+#> Cell1121 3.451297e+00 0.8653639
+#> Cell1008 4.445477e+00 0.8714246
+#> Cell322 -3.356956e+00 0.8238596
+#> Cell1518 3.334957e+00 0.8646547
+#> Cell1705 5.468638e+00 0.8776620
+#> Cell635 -3.675396e+00 0.8219183
+#> Cell30 -3.949773e+00 0.8202457
+#> Cell1367 5.942579e+00 0.8805512
+#> Cell1310 4.007849e+00 0.8687567
+#> Cell790 2.133720e+00 0.8573317
+#> Cell1303 8.129756e+00 0.8938846
+#> Cell11 -7.769006e-01 0.8395881
+#> Cell1990 4.541059e+00 0.8720073
+#> Cell1667 4.530620e+00 0.8719436
+#> Cell1525 4.976567e+00 0.8746622
+#> Cell1264 2.241702e+00 0.8579900
+#> Cell300 -5.669292e+00 0.8097632
+#> Cell33 -1.984246e+00 0.8322279
+#> Cell675 -2.847706e+00 0.8269641
+#> Cell245 -2.076642e+00 0.8316646
+#> Cell899 -4.974173e+00 0.8140008
+#> Cell655 -1.051595e-01 0.8436831
+#> Cell1578 5.409611e+00 0.8773021
+#> Cell921 -3.007083e+00 0.8259925
+#> Cell1146 1.165036e+00 0.8514264
+#> Cell10 -2.457011e+00 0.8293458
+#> Cell313 -4.136987e+00 0.8191044
+#> Cell164 -4.979041e+00 0.8139711
+#> Cell769 -2.294246e+00 0.8303381
+#> Cell89 3.843922e-01 0.8466675
+#> Cell1238 2.861060e+00 0.8617657
+#> Cell218 -4.935780e+00 0.8142348
+#> Cell1029 4.628309e+00 0.8725392
+#> Cell329 -3.813460e+00 0.8210767
+#> Cell1535 2.602377e+00 0.8601887
+#> Cell1711 3.876811e+00 0.8679579
+#> Cell1914 -4.891481e-02 0.8440260
+#> Cell1685 2.508357e+00 0.8596156
+#> Cell1014 3.840938e+00 0.8677392
+#> Cell1267 4.974226e-01 0.8473566
+#> Cell1774 4.899100e+00 0.8741900
+#> Cell1144 1.532099e+00 0.8536641
+#> Cell918 -6.040228e+00 0.8075019
+#> Cell1760 5.904522e+00 0.8803192
+#> Cell996 -5.695054e-02 0.8439770
+#> Cell525 -2.090867e+00 0.8315779
+#> Cell1389 2.483952e+00 0.8594668
+#> Cell1034 6.959922e+00 0.8867531
+#> Cell932 -3.111385e+00 0.8253566
+#> Cell600 -6.578845e-01 0.8403136
+#> Cell949 -6.211386e+00 0.8064585
+#> Cell983 -3.723058e+00 0.8216278
+#> Cell1834 5.053115e+00 0.8751289
+#> Cell919 -3.896413e+00 0.8205710
+#> Cell844 -1.959530e+01 0.7248678
+#> Cell751 -3.933877e+00 0.8203426
+#> Cell1107 1.434083e+00 0.8530666
+#> Cell556 -5.257318e+00 0.8122747
+#> Cell710 -3.247728e+00 0.8245255
+#> Cell979 -2.019439e+00 0.8320133
+#> Cell799 -5.265791e+00 0.8122230
+#> Cell805 5.533784e+00 0.8780591
+#> Cell1932 7.419869e+00 0.8895570
+#> Cell175 -2.311414e+00 0.8302334
+#> Cell1004 4.473263e+00 0.8715940
+#> Cell1946 2.947396e+00 0.8622920
+#> Cell1551 3.317192e+00 0.8645464
+#> Cell807 -6.101310e+00 0.8071295
+#> Cell1064 2.865409e+00 0.8617922
+#> Cell780 -7.327077e+00 0.7996570
+#> Cell1317 6.142486e+00 0.8817699
+#> Cell1784 4.624069e+00 0.8725133
+#> Cell765 -4.497115e+00 0.8169090
+#> Cell349 -2.462344e+00 0.8293133
+#> Cell1971 -1.028719e-01 0.8436971
+#> Cell1126 1.558196e+00 0.8538232
+#> Cell190 -2.002755e+00 0.8321150
+#> Cell1593 4.981784e+00 0.8746940
+#> Cell1487 4.147450e+00 0.8696078
+#> Cell1415 5.669699e+00 0.8788877
+#> Cell735 -8.851880e+00 0.7903616
+#> Cell847 1.229968e+00 0.8518223
+#> Cell514 -1.222314e+00 0.8368727
+#> Cell1344 2.517354e+00 0.8596704
+#> Cell409 -2.757316e+00 0.8275151
+#> Cell1489 3.370765e+00 0.8648730
+#> Cell835 -6.185538e+00 0.8066161
+#> Cell411 -9.522105e-01 0.8385193
+#> Cell112 -4.408377e+00 0.8174499
+#> Cell1388 6.256343e-01 0.8481382
+#> Cell373 -5.618769e+00 0.8100712
+#> Cell248 -2.039951e+00 0.8318883
+#> Cell788 -4.225321e+00 0.8185659
+#> Cell462 -6.449409e+00 0.8050075
+#> Cell1918 2.543404e+00 0.8598292
+#> Cell230 -1.752529e+01 0.7374869
+#> Cell236 -2.320017e+00 0.8301810
+#> Cell1849 5.286355e+00 0.8765507
+#> Cell1364 5.600514e+00 0.8784659
+#> Cell1529 5.561813e+00 0.8782300
+#> Cell1010 2.789918e+00 0.8613320
+#> Cell1630 3.222510e+00 0.8639692
+#> Cell1731 3.162726e+00 0.8636047
+#> Cell344 -5.460696e+00 0.8110348
+#> Cell1958 4.919009e+00 0.8743113
+#> Cell630 -4.594423e+00 0.8163158
+#> Cell1542 1.892750e+00 0.8558627
+#> Cell1864 5.315059e+00 0.8767257
+#> Cell791 -1.696228e+00 0.8339837
+#> Cell1979 2.498944e+00 0.8595582
+#> Cell1329 3.096531e+00 0.8632012
+#> Cell1743 4.683413e+00 0.8728751
+#> Cell1638 3.724671e+00 0.8670304
+#> Cell93 -1.680101e+00 0.8340820
+#> Cell1181 8.377766e+00 0.8953965
+#> Cell1491 1.250303e+00 0.8519462
+#> Cell1718 3.321093e+00 0.8645701
+#> Cell992 -7.071854e+00 0.8012129
+#> Cell612 -5.328573e+00 0.8118403
+#> Cell1599 3.265567e-01 0.8463149
+#> Cell821 -4.883403e+00 0.8145541
+#> Cell532 -4.282955e+00 0.8182145
+#> Cell1991 3.531548e+00 0.8658531
+#> Cell221 -5.022717e+00 0.8137048
+#> Cell1600 5.104067e+00 0.8754395
+#> Cell782 -2.202498e+00 0.8308974
+#> Cell160 -1.700813e+01 0.7406396
+#> Cell1212 3.329497e+00 0.8646214
+#> Cell1383 5.131598e+00 0.8756073
+#> Cell200 -3.487177e+00 0.8230657
+#> Cell479 -8.092531e-01 0.8393908
+#> Cell989 6.306347e-01 0.8481686
+#> Cell387 -7.790524e+00 0.7968318
+#> Cell1150 1.380178e+01 0.9284623
+#> Cell871 -4.625526e+00 0.8161262
+#> Cell486 -3.492258e+00 0.8230348
+#> Cell1109 8.857411e+00 0.8983205
+#> Cell1425 7.100450e+00 0.8876098
+#> Cell1434 2.771523e+00 0.8612199
+#> Cell266 -2.255521e+00 0.8305741
+#> Cell1732 7.582570e+00 0.8905489
+#> Cell642 -1.078781e+01 0.7785598
+#> Cell1516 2.401470e+00 0.8589640
+#> Cell1642 4.107392e+00 0.8693636
+#> Cell1045 -1.481385e+00 0.8352934
+#> Cell698 -2.272651e+00 0.8304697
+#> Cell611 -3.862316e-01 0.8419696
+#> Cell1540 4.171762e+00 0.8697560
+#> Cell1733 2.251957e+00 0.8580525
+#> Cell20 -3.688963e+00 0.8218356
+#> Cell201 -1.587512e+00 0.8346464
+#> Cell174 -3.911275e+00 0.8204804
+#> Cell1138 -4.133390e-01 0.8418044
+#> Cell1798 3.854174e+00 0.8678199
+#> Cell276 -1.879459e+00 0.8328667
+#> Cell1032 3.445563e+00 0.8653289
+#> Cell291 -1.152224e+01 0.7740826
+#> Cell85 -3.751385e+00 0.8214551
+#> Cell789 -1.475443e+00 0.8353296
+#> Cell1937 2.620327e+00 0.8602982
+#> Cell1753 4.307346e+00 0.8705825
+#> Cell1713 2.800927e+00 0.8613991
+#> Cell1408 4.944347e+00 0.8744658
+#> Cell1478 4.942109e+00 0.8744521
+#> Cell346 -9.100278e+00 0.7888473
+#> Cell1880 5.570869e+00 0.8782852
+#> Cell916 -7.622405e+00 0.7978567
+#> Cell1259 2.834473e+00 0.8616036
+#> Cell497 -4.234679e+00 0.8185088
+#> Cell671 -2.980141e+00 0.8261567
+#> Cell1119 5.987505e+00 0.8808251
+#> Cell1588 3.693785e+00 0.8668421
+#> Cell1790 1.074226e+01 0.9098109
+#> Cell739 -1.945995e+00 0.8324611
+#> Cell1429 3.684289e+00 0.8667843
+#> Cell937 -8.115943e+00 0.7948480
+#> Cell777 -1.352596e+00 0.8360785
+#> Cell1800 6.694702e+00 0.8851363
+#> Cell1813 8.061320e+00 0.8934674
+#> Cell1151 3.697736e+00 0.8668662
+#> Cell1981 1.140097e+00 0.8512744
+#> Cell271 -2.534469e+00 0.8288736
+#> Cell1624 3.008374e+00 0.8626638
+#> Cell1632 1.683145e+00 0.8545849
+#> Cell327 -4.066607e+00 0.8195334
+#> Cell704 -8.376011e+00 0.7932626
+#> Cell1366 2.958402e+00 0.8623591
+#> Cell186 -3.682899e+00 0.8218726
+#> Cell1083 3.119371e+00 0.8633404
+#> Cell158 -2.011055e+00 0.8320644
+#> Cell1709 7.858540e+00 0.8922312
+#> Cell959 -1.348652e+00 0.8361026
+#> Cell135 -5.059855e+00 0.8134784
+#> Cell1302 1.834924e+00 0.8555102
+#> Cell696 -2.936196e+00 0.8264246
+#> Cell64 -1.743308e+00 0.8336967
+#> Cell123 -1.928199e+00 0.8325695
+#> Cell581 -1.386549e+00 0.8358715
+#> Cell489 -5.886958e+00 0.8084363
+#> Cell1592 2.091354e+00 0.8570734
+#> Cell1180 3.228465e+00 0.8640055
+#> Cell354 -1.777761e+00 0.8334866
+#> Cell1611 3.941651e+00 0.8683532
+#> Cell885 -3.069707e+00 0.8256107
+#> Cell1714 7.859776e+00 0.8922388
+#> Cell1152 3.953152e+00 0.8684233
+#> Cell44 -9.462637e+00 0.7866383
+#> Cell2000 4.809645e+00 0.8736446
+#> Cell217 -3.335877e+00 0.8239881
+#> Cell1999 4.324124e+00 0.8706848
+#> Cell254 -1.182114e+01 0.7722604
+#> Cell1651 3.300399e+00 0.8644440
+#> Cell297 -4.806658e+00 0.8150220
+#> Cell879 -8.904718e+00 0.7900395
+#> Cell454 -5.030831e+00 0.8136554
+#> Cell1942 3.309939e+00 0.8645021
+#> Cell1167 3.331132e+00 0.8646313
+#> Cell178 -3.881347e+00 0.8206628
+#> Cell958 -5.000886e+00 0.8138379
+#> Cell55 -2.497973e-01 0.8428014
+#> Cell34 -2.016121e+00 0.8320336
+#> Cell1157 4.395226e+00 0.8711182
+#> Cell362 1.725328e+00 0.8548421
+#> Cell369 -2.715544e+00 0.8277698
+#> Cell862 -3.828964e+00 0.8209821
+#> Cell1274 7.028437e+00 0.8871708
+#> Cell252 -2.419737e+00 0.8295730
+#> Cell1296 3.300301e+00 0.8644434
+#> Cell88 7.329084e-01 0.8487921
+#> Cell1955 4.538133e+00 0.8719894
+#> Cell855 -2.597148e+00 0.8284915
+#> Cell1868 5.307151e+00 0.8766775
+#> Cell1538 4.116599e+00 0.8694197
+#> Cell1226 2.511031e+00 0.8596319
+#> Cell1926 5.464900e+00 0.8776392
+#> Cell188 -3.004406e-01 0.8424926
+#> Cell1855 1.081399e-01 0.8449834
+#> Cell1416 2.954025e+00 0.8623324
+#> Cell529 1.985034e-01 0.8455343
+#> Cell923 -4.207263e+00 0.8186760
+#> Cell1643 5.427486e+00 0.8774111
+#> Cell1409 3.526214e+00 0.8658206
+#> Cell1184 5.873788e+00 0.8801318
+#> Cell31 -4.871164e+00 0.8146287
+#> Cell518 -5.928803e+00 0.8081812
+#> Cell1092 3.474113e+00 0.8655030
+#> Cell1531 5.842394e+00 0.8799404
+#> Cell742 -2.084118e+00 0.8316190
+#> Cell1334 2.635728e+00 0.8603920
+#> Cell106 -4.433566e+00 0.8172964
+#> Cell863 -4.569219e+00 0.8164694
+#> Cell1373 1.515291e+00 0.8535617
+#> Cell187 -2.116926e+00 0.8314190
+#> Cell1773 5.400550e+00 0.8772469
+#> Cell1726 1.127872e+01 0.9130812
+#> Cell1573 2.917304e+00 0.8621086
+#> Cell1442 5.682652e+00 0.8789666
+#> Cell1473 4.643146e+00 0.8726296
+#> Cell1639 3.292805e+00 0.8643977
+#> Cell1852 1.458071e+00 0.8532128
+#> Cell1261 3.140157e+00 0.8634671
+#> Cell1422 1.957907e+00 0.8562599
+#> Cell1293 2.612562e+00 0.8602508
+#> Cell1842 4.937515e+00 0.8744241
+#> Cell353 -1.083505e+01 0.7782718
+#> Cell1881 2.162978e+00 0.8575101
+#> Cell1170 5.846668e+00 0.8799665
+#> Cell1995 4.082654e-01 0.8468130
+#> Cell1899 1.443446e+00 0.8531237
+#> Cell68 -7.757721e+00 0.7970318
+#> Cell1322 2.270152e+00 0.8581634
+#> Cell471 8.834481e-02 0.8448627
+#> Cell1399 -1.224704e+00 0.8368582
+#> Cell586 -6.309902e+00 0.8058579
+#> Cell1586 2.698655e+00 0.8607757
+#> Cell578 2.813923e+00 0.8614784
+#> Cell1158 1.812324e+00 0.8553724
+#> Cell912 -5.487815e-01 0.8409787
+#> Cell1498 4.065122e+00 0.8691059
+#> Cell499 -1.612529e+00 0.8344939
+#> Cell1260 2.323416e+00 0.8584881
+#> Cell1182 2.487085e+00 0.8594859
+#> Cell1492 1.367947e+00 0.8526634
+#> Cell1512 4.714016e+00 0.8730616
+#> Cell552 -2.475870e+00 0.8292308
+#> Cell256 -5.303474e+00 0.8119933
+#> Cell1691 2.841201e+00 0.8616446
+#> Cell995 -6.917045e+00 0.8021567
+#> Cell431 -4.766562e+00 0.8152664
+#> Cell1723 3.806164e+00 0.8675272
+#> Cell1975 1.654987e+00 0.8544133
+#> Cell1160 3.424894e+00 0.8652029
+#> Cell1816 3.808554e+00 0.8675418
+#> Cell162 -2.949866e+00 0.8263413
+#> Cell934 -4.184356e+00 0.8188156
+#> Cell1483 3.296511e+00 0.8644203
+#> Cell1353 3.306926e+00 0.8644838
+#> Cell1420 1.160349e+00 0.8513979
+#> Cell1530 1.902499e+00 0.8559221
+#> Cell1708 2.704543e+00 0.8608116
+#> Cell848 -6.573896e+00 0.8042486
+#> Cell1453 6.930855e+00 0.8865759
+#> Cell1669 9.520692e-01 0.8501282
+#> Cell591 -6.593842e-01 0.8403045
+#> Cell1763 3.105260e+00 0.8632544
+#> Cell1517 5.372094e+00 0.8770734
+#> Cell1947 2.093310e+00 0.8570854
+#> Cell341 -6.436180e+00 0.8050881
+#> Cell1306 1.498045e+00 0.8534565
+#> Cell234 -3.633526e+00 0.8221736
+#> Cell443 -3.248022e-01 0.8423441
+#> Cell603 6.620379e-01 0.8483601
+#> Cell1964 5.282284e+00 0.8765259
+#> Cell1384 5.632130e+00 0.8786586
+#> Cell293 -3.756013e+00 0.8214269
+#> Cell1954 5.827709e+00 0.8798509
+#> Cell1719 3.982895e+00 0.8686046
+#> Cell622 -3.458374e+00 0.8232413
+#> Cell1591 8.518784e+00 0.8962562
+#> Cell153 -3.890934e+00 0.8206044
+#> Cell469 -7.046617e+00 0.8013668
+#> Cell92 -2.264823e+00 0.8305174
+#> Cell1343 6.124401e+00 0.8816596
+#> Cell1405 3.858295e+00 0.8678450
+#> Cell415 -3.688228e+00 0.8218401
+#> Cell1746 8.618894e-01 0.8495784
+#> Cell81 -4.347717e+00 0.8178197
+#> Cell887 -2.846891e+00 0.8269690
+#> Cell981 1.105003e+00 0.8510605
+#> Cell1252 3.909414e+00 0.8681567
+#> Cell75 -2.210378e+00 0.8308493
+#> Cell917 -4.719723e+00 0.8155519
+#> Cell1147 2.686012e+00 0.8606986
+#> Cell1577 1.565862e+00 0.8538699
+#> Cell1444 1.768307e+00 0.8551041
+#> Cell836 -9.744687e+00 0.7849189
+#> Cell1046 5.927376e+00 0.8804585
+#> Cell286 5.631364e+00 0.8786540
+#> Cell337 -6.138043e+00 0.8069056
+#> Cell1374 9.645347e-01 0.8502042
+#> Cell647 -3.360193e+00 0.8238399
+#> Cell1270 3.120615e+00 0.8633480
+#> Cell1359 1.143667e+00 0.8512962
+#> Cell970 -1.220228e+01 0.7699370
+#> Cell249 -8.572195e-01 0.8390984
+#> Cell1817 2.473187e+00 0.8594012
+#> Cell1401 2.894140e+00 0.8619674
+#> Cell66 -7.957104e+00 0.7958163
+#> Cell1172 2.695875e+00 0.8607587
+#> Cell284 2.358416e+00 0.8587015
+#> Cell302 -1.948362e+00 0.8324466
+#> Cell9 -8.838599e-01 0.8389360
+#> Cell1892 4.172628e+00 0.8697612
+#> Cell1024 3.575678e+00 0.8661221
+#> Cell1033 1.079385e+01 0.9101254
+#> Cell141 -2.163524e+00 0.8311350
+#> Cell257 -6.367491e+00 0.8055068
+#> Cell39 -3.285300e+00 0.8242964
+#> Cell1956 8.552491e+00 0.8964617
+#> Cell842 -5.304538e+00 0.8119868
+#> Cell894 -3.946586e+00 0.8202651
+#> Cell1412 4.684050e+00 0.8728790
+#> Cell1965 2.819975e+00 0.8615152
+#> Cell1040 4.634880e+00 0.8725792
+#> Cell1071 4.395256e+00 0.8711184
+#> Cell285 -4.128973e+00 0.8191532
+#> Cell1776 1.729879e+00 0.8548698
+#> Cell1920 2.417015e+00 0.8590587
+#> Cell1766 5.619921e+00 0.8785842
+#> Cell1521 3.146339e+00 0.8635048
+#> Cell681 -1.126704e+00 0.8374556
+#> Cell1244 7.732166e-01 0.8490378
+#> Cell1438 6.218522e+00 0.8822334
+#> Cell125 -3.022339e+00 0.8258995
+#> Cell99 -3.397827e+00 0.8236104
+#> Cell1463 5.337364e+00 0.8768617
+#> Cell1370 4.733620e+00 0.8731812
+#> Cell1449 2.973987e+00 0.8624541
+#> Cell1297 -8.172260e-01 0.8393422
+#> Cell1139 7.321686e+00 0.8889585
+#> Cell1617 1.782221e+00 0.8551889
+#> Cell62 -2.814114e-01 0.8426086
+#> Cell795 -9.785981e+00 0.7846671
+#> Cell1368 4.464679e+00 0.8715416
+#> Cell784 1.270151e+00 0.8520672
+#> Cell1361 3.992385e+00 0.8686625
+#> Cell1505 3.408884e+00 0.8651053
+#> Cell1135 2.600027e+00 0.8601744
+#> Cell1133 3.403061e+00 0.8650698
+#> Cell693 -5.025854e+00 0.8136857
+#> Cell1386 1.636957e+00 0.8543034
+#> Cell1762 2.058807e+00 0.8568750
+#> Cell434 -9.784709e+00 0.7846749
+#> Cell1890 4.997894e+00 0.8747922
+#> Cell335 -1.024198e+00 0.8380805
+#> Cell213 -4.133438e+00 0.8191260
+#> Cell1993 3.835135e+00 0.8677038
+#> Cell775 -1.172671e+00 0.8371754
+#> Cell1948 3.381771e+00 0.8649400
+#> Cell1507 3.327981e+00 0.8646121
+#> Cell1635 5.823155e+00 0.8798232
+#> Cell966 -3.553126e-01 0.8421581
+#> Cell439 -9.814852e-01 0.8383409
+#> Cell1596 5.547734e+00 0.8781441
+#> Cell159 -9.072961e-01 0.8387931
+#> Cell772 -3.498057e+00 0.8229994
+#> Cell535 -3.689246e-01 0.8420752
+#> Cell131 1.775726e+00 0.8551493
+#> Cell1245 2.669524e+00 0.8605981
+#> Cell1541 4.470637e+00 0.8715780
+#> Cell315 -6.550499e+00 0.8043912
+#> Cell412 -1.876144e+00 0.8328869
+#> Cell1626 3.863855e+00 0.8678789
+#> Cell939 -2.964059e+00 0.8262548
+#> Cell1145 1.761428e+00 0.8550622
+#> Cell554 -5.919187e+00 0.8082398
+#> Cell521 -1.040847e+00 0.8379790
+#> Cell1320 4.232163e+00 0.8701242
+#> Cell625 -8.282925e+00 0.7938300
+#> Cell1789 6.472559e+00 0.8837820
+#> Cell1660 2.148320e+00 0.8574207
+#> Cell372 -3.199535e+00 0.8248193
+#> Cell1843 4.714859e+00 0.8730668
+#> Cell1077 3.144718e+00 0.8634949
+#> Cell1919 3.676086e+00 0.8667342
+#> Cell305 -3.229468e+00 0.8246368
+#> Cell1227 2.922140e+00 0.8621381
+#> Cell720 -3.251843e+00 0.8245004
+#> Cell1500 5.235602e+00 0.8762413
+#> Cell1234 5.571832e+00 0.8782910
+#> Cell1350 5.012268e+00 0.8748798
+#> Cell425 -1.153365e+00 0.8372931
+#> Cell904 -8.792506e+00 0.7907235
+#> Cell392 3.146944e+00 0.8635085
+#> Cell1966 1.313419e+00 0.8523310
+#> Cell241 -2.079388e+00 0.8316479
+#> Cell1001 3.775665e+00 0.8673413
+#> Cell1235 4.870658e+00 0.8740166
+#> Cell1127 3.357789e+00 0.8647938
+#> Cell115 -6.727406e+00 0.8033127
+#> Cell1607 -2.116326e+00 0.8314227
+#> Cell1598 1.061385e+01 0.9090280
+#> Cell90 2.838962e-01 0.8460549
+#> Cell963 -3.722377e+00 0.8216319
+#> Cell250 -4.339542e+00 0.8178696
+#> Cell1307 1.940139e+00 0.8561516
+#> Cell976 -4.902253e+00 0.8144392
+#> Cell640 2.876903e-01 0.8460780
+#> Cell599 -3.898275e+00 0.8205596
+#> Cell936 -3.497310e+00 0.8230040
+#> Cell562 -2.520909e-01 0.8427874
+#> Cell1827 1.750728e+00 0.8549969
+#> Cell294 -4.536029e+00 0.8166718
+#> Cell1503 4.310370e+00 0.8706010
+#> Cell1061 1.054413e+00 0.8507521
+#> Cell1563 3.111450e+00 0.8632921
+#> Cell613 -6.936688e+00 0.8020369
+#> Cell1822 2.617660e+00 0.8602819
+#> Cell999 -2.091833e+00 0.8315720
+#> Cell420 -1.141746e+00 0.8373639
+#> Cell977 -1.739452e+00 0.8337202
+#> Cell1446 6.314464e+00 0.8828183
+#> Cell23 -4.026703e+00 0.8197767
+#> Cell1269 -1.802157e-01 0.8432256
+#> Cell1664 4.272084e+00 0.8703676
+#> Cell374 -1.988833e+00 0.8321999
+#> Cell1348 7.664510e-01 0.8489966
+#> Cell1012 2.441326e+00 0.8592069
+#> Cell404 -4.687260e+00 0.8157498
+#> Cell1720 6.228644e+00 0.8822951
+#> Cell522 -8.842502e-01 0.8389336
+#> Cell385 -5.286339e+00 0.8120977
+#> Cell1497 3.874218e+00 0.8679421
+#> Cell244 -4.554701e+00 0.8165579
+#> Cell806 -2.508081e+00 0.8290345
+#> Cell259 -7.553028e+00 0.7982796
+#> Cell504 -4.652897e+00 0.8159593
+#> Cell707 -3.654021e+00 0.8220486
+#> Cell1779 1.120540e+01 0.9126343
+#> Cell585 6.055401e-01 0.8480157
+#> Cell534 -2.841561e+00 0.8270015
+#> Cell498 -3.702193e-01 0.8420673
+#> Cell530 -5.663249e+00 0.8098000
+#> Cell228 -5.412731e+00 0.8113272
+#> Cell1054 2.176785e+00 0.8575942
+#> Cell1336 1.946799e+00 0.8561922
+#> Cell1155 4.998723e+00 0.8747973
+#> Cell729 -2.750616e+00 0.8275559
+#> Cell1199 4.850943e-01 0.8472814
+#> Cell1101 2.726820e+00 0.8609474
+#> Cell701 1.541115e+00 0.8537191
+#> Cell1031 5.056765e+00 0.8751511
+#> Cell314 -5.036892e+00 0.8136184
+#> Cell1250 1.929087e+00 0.8560842
+#> Cell1454 8.028274e-01 0.8492184
+#> Cell1279 4.008096e+00 0.8687582
+#> Cell1640 4.442638e+00 0.8714073
+#> Cell1108 2.985326e+00 0.8625232
+#> Cell1216 3.260352e+00 0.8641999
+#> Cell1106 5.098449e+00 0.8754052
+#> Cell1316 4.212489e+00 0.8700042
+#> Cell634 -6.896020e+00 0.8022848
+#> Cell741 -3.659584e+00 0.8220147
+#> Cell724 -6.680321e+00 0.8035998
+#> Cell1622 6.550178e+00 0.8842552
+#> Cell513 -1.625010e+00 0.8344178
+#> Cell378 -4.344728e-01 0.8416756
+#> Cell1872 7.147272e+00 0.8878952
+#> Cell1120 3.633497e+00 0.8664746
+#> Cell1295 4.433529e+00 0.8713517
+#> Cell1186 4.642131e+00 0.8726234
+#> Cell1960 2.263397e+00 0.8581222
+#> Cell1567 4.235475e+00 0.8701444
+#> Cell1671 4.161648e+00 0.8696943
+#> Cell1756 4.106706e+00 0.8693594
+#> Cell134 -2.864676e+00 0.8268606
+#> Cell523 -7.890380e+00 0.7962230
+#> Cell1755 1.372906e+00 0.8526937
+#> Cell1048 1.228168e+00 0.8518113
+#> Cell1707 7.463656e-02 0.8447792
+#> Cell1884 2.920809e+00 0.8621299
+#> Cell781 -5.581494e+00 0.8102984
+#> Cell1421 4.339233e+00 0.8707769
+#> Cell1646 3.497326e+00 0.8656445
+#> Cell888 -2.136140e+00 0.8313019
+#> Cell1608 4.161315e+00 0.8696923
+#> Cell467 -5.588368e+00 0.8102565
+#> Cell401 -1.597301e+01 0.7469499
+#> Cell817 -1.818904e+00 0.8332358
+#> Cell422 -1.683599e+00 0.8340607
+#> Cell279 -5.463197e+00 0.8110196
+#> Cell573 -2.998001e+00 0.8260478
+#> Cell1240 3.497488e+00 0.8656455
+#> Cell1736 3.700279e+00 0.8668817
+#> Cell360 -7.501587e+00 0.7985932
+#> Cell1104 4.255658e+00 0.8702674
+#> Cell299 -1.121189e+01 0.7759745
+#> Cell565 -1.012065e+00 0.8381545
+#> Cell1727 4.097341e+00 0.8693023
+#> Cell1941 8.133612e+00 0.8939081
+#> Cell1528 3.219728e+00 0.8639522
+#> Cell367 -5.155110e+00 0.8128977
+#> Cell1803 4.827867e+00 0.8737557
+#> Cell621 -4.709343e+00 0.8156152
+#> Cell849 -6.875967e+00 0.8024071
+#> Cell1251 2.525552e+00 0.8597204
+#> Cell386 -7.252081e+00 0.8001142
+#> Cell336 -1.709403e+00 0.8339034
+#> Cell1099 1.345223e+00 0.8525249
+#> Cell808 3.138943e+00 0.8634597
+#> Cell1835 1.384617e+01 0.9287328
+#> Cell854 -5.590518e-01 0.8409161
+#> Cell866 -4.471698e+00 0.8170639
+#> Cell1996 1.513606e+00 0.8535514
+#> Cell1124 5.454201e-01 0.8476492
+#> Cell740 -3.228914e+00 0.8246402
+#> Cell426 -2.136323e+00 0.8313008
+#> Cell436 -1.509923e+00 0.8351194
+#> Cell1589 5.551011e+00 0.8781641
+#> Cell1610 4.734751e+00 0.8731881
+#> Cell915 -1.184811e+00 0.8371014
+#> Cell172 -7.005306e-01 0.8400536
+#> Cell1897 2.161411e+00 0.8575005
+#> Cell1169 4.488091e+00 0.8716844
+#> Cell1549 3.694011e+00 0.8668435
+#> Cell1788 5.821074e+00 0.8798105
+#> Cell1722 2.830832e+00 0.8615814
+#> Cell450 -6.828779e+00 0.8026947
+#> Cell579 -3.504593e+00 0.8229596
+#> Cell1177 3.311328e+00 0.8645106
+#> Cell1992 2.356146e+00 0.8586877
+#> Cell233 -5.731860e+00 0.8093818
+#> Cell761 -6.027181e+00 0.8075814
+#> Cell925 6.077224e-01 0.8480290
+#> Cell732 -6.250359e+00 0.8062209
+#> Cell1214 2.423492e+00 0.8590982
+#> Cell1533 2.335500e+00 0.8585618
+#> Cell1179 5.424837e-01 0.8476313
+#> Cell1206 3.879335e+00 0.8679733
+#> Cell1944 3.031898e+00 0.8628072
+#> Cell667 -5.035387e+00 0.8136276
+#> Cell677 -1.701958e+00 0.8339487
+#> Cell366 -5.784739e+00 0.8090594
+#> Cell1263 3.763026e+00 0.8672642
+#> Cell1082 2.156869e+00 0.8574728
+#> Cell1677 2.107119e+00 0.8571695
+#> Cell298 -3.485523e+00 0.8230758
+#> Cell785 -2.007245e+00 0.8320877
+#> Cell1970 5.304286e+00 0.8766600
+#> Cell1684 3.338175e+00 0.8646743
+#> Cell1545 1.888877e+00 0.8558391
+#> Cell1006 4.861111e+00 0.8739584
+#> Cell1806 2.120350e+00 0.8572502
+#> Cell1246 2.448497e+00 0.8592506
+#> Cell1641 3.354311e+00 0.8647727
+#> Cell1558 5.255201e+00 0.8763608
+#> Cell251 -2.154466e+00 0.8311902
+#> Cell755 -4.475972e+00 0.8170379
+#> Cell628 -3.189371e+00 0.8248812
+#> Cell1739 2.102815e+00 0.8571433
+#> Cell76 -6.437924e+00 0.8050775
+#> Cell437 -1.963356e+00 0.8323552
+#> Cell1266 1.707764e+00 0.8547350
+#> Cell1735 8.016568e-01 0.8492112
+#> Cell1506 4.107172e+00 0.8693622
+#> Cell445 -1.237742e+00 0.8367787
+#> Cell1613 6.837193e+00 0.8860049
+#> Cell1694 6.047569e+00 0.8811912
+#> Cell393 -4.865025e+00 0.8146661
+#> Cell1390 5.618155e+00 0.8785734
+#> Cell379 -3.685803e+00 0.8218549
+#> Cell520 -3.978582e+00 0.8200701
+#> Cell1 -1.070547e-01 0.8436716
+#> Cell126 -1.729903e+00 0.8337784
+#> Cell1360 4.236161e+00 0.8701486
+#> Cell1076 2.289754e+00 0.8582829
+#> Cell267 -1.569615e+00 0.8347555
+#> Cell561 -5.958784e+00 0.8079984
+#> Cell994 -9.416685e+00 0.7869184
+#> Cell860 -3.278277e+00 0.8243392
+#> Cell1439 8.881405e-01 0.8497384
+#> Cell1342 3.893844e+00 0.8680617
+#> Cell1943 6.527310e+00 0.8841158
+#> Cell1752 1.768543e+00 0.8551055
+#> Cell730 -6.648068e+00 0.8037964
+#> Cell1829 4.823960e+00 0.8737319
+#> Cell1067 2.038783e+00 0.8567530
+#> Cell238 -7.829027e+00 0.7965971
+#> Cell1768 5.093900e+00 0.8753775
+#> Cell1337 2.883116e+00 0.8619002
+#> Cell859 -3.457021e+00 0.8232496
+#> Cell500 -7.090577e+00 0.8010988
+#> Cell609 -5.921293e+00 0.8082269
+#> Cell800 -3.810778e+00 0.8210930
+#> Cell273 -2.541050e+00 0.8288335
+#> Cell1480 2.820251e+00 0.8615169
+#> Cell1369 4.761970e+00 0.8733540
+#> Cell47 -2.677477e-01 0.8426919
+#> Cell1192 2.834217e+00 0.8616021
+#> Cell1510 6.310530e+00 0.8827943
+#> Cell1957 5.910272e+00 0.8803542
+#> Cell1282 3.383314e+00 0.8649495
+#> Cell1502 2.014902e+00 0.8566074
+#> Cell1115 9.267987e+00 0.9008235
+#> Cell1597 3.834620e+00 0.8677007
+#> Cell1471 3.415747e+00 0.8651472
+#> Cell1605 3.501326e+00 0.8656689
+#> Cell1211 3.809431e+00 0.8675471
+#> Cell334 -5.946781e+00 0.8080716
+#> Cell1582 3.733590e+00 0.8670848
+#> Cell1088 7.047853e+00 0.8872891
+#> Cell1900 2.649728e+00 0.8604774
+#> Cell633 -1.760604e+00 0.8335912
+#> Cell1140 4.764271e+00 0.8733680
+#> Cell459 3.486886e-01 0.8464498
+#> Cell945 -1.874992e+00 0.8328939
+#> Cell883 -7.844705e+00 0.7965015
+#> Cell1142 2.224181e+00 0.8578832
+#> Cell1171 5.107751e+00 0.8754619
+#> Cell1987 2.053340e+00 0.8568417
+#> Cell132 -2.533510e+00 0.8288795
+#> Cell1136 2.629879e+00 0.8603564
+#> Cell1445 4.173118e+00 0.8697642
+#> Cell1200 1.760294e+00 0.8550552
+#> Cell193 -6.290203e+00 0.8059780
+#> Cell1175 3.283677e+00 0.8643420
+#> Cell1658 4.537313e+00 0.8719844
+#> Cell1583 5.480168e+00 0.8777322
+#> Cell319 -2.812208e+00 0.8271805
+#> Cell1749 1.378398e+00 0.8527271
+#> Cell1393 5.596570e+00 0.8784419
+#> Cell1621 1.333477e+00 0.8524533
+#> Cell830 -5.134259e+00 0.8130248
+#> Cell1863 1.380146e+00 0.8527378
+#> Cell641 2.290562e+00 0.8582878
+#> Cell1936 3.466920e+00 0.8654591
+#> Cell728 -9.467140e-01 0.8385528
+#> Cell980 -1.941271e+00 0.8324899
+#> Cell1704 7.553572e-01 0.8489290
+#> Cell342 -5.726945e+00 0.8094117
+#> Cell1321 5.487962e+00 0.8777798
+#> Cell491 -2.693672e+00 0.8279031
+#> Cell1223 3.585600e+00 0.8661826
+#> Cell1659 4.608718e+00 0.8724197
+#> Cell890 1.133067e+00 0.8512316
+#> Cell1333 4.421323e+00 0.8712773
+#> Cell1468 3.555121e+00 0.8659968
+#> Cell1945 1.111527e+00 0.8511002
+#> Cell1781 7.889315e-01 0.8491336
+#> Cell424 -3.293795e+00 0.8242446
+#> Cell382 -1.015574e+01 0.7824130
+#> Cell709 -5.325916e+00 0.8118565
+#> Cell1233 7.272342e-02 0.8447675
+#> Cell629 1.547001e+00 0.8537550
+#> Cell1501 6.298582e-01 0.8481639
+#> Cell1740 3.259529e+00 0.8641948
+#> Cell557 -4.548873e+00 0.8165935
+#> Cell1826 3.305104e+00 0.8644727
+#> Cell3 -1.776182e+00 0.8334963
+#> Cell101 -6.135859e-01 0.8405837
+#> Cell1349 4.322582e+00 0.8706754
+#> Cell1858 5.744264e+00 0.8793422
+#> Cell1961 4.397947e+00 0.8711348
+#> Cell990 -1.891222e-01 0.8431713
+#> Cell547 7.731322e-02 0.8447955
+#> Cell451 -1.675322e+00 0.8341111
+#> Cell1021 4.769793e+00 0.8734017
+#> Cell301 -7.280541e+00 0.7999407
+#> Cell886 -2.352136e+00 0.8299852
+#> Cell65 -5.238278e+00 0.8123907
+#> Cell1414 2.015881e+00 0.8566133
+#> Cell1968 3.514429e+00 0.8657488
+#> Cell1347 4.130869e+00 0.8695067
+#> Cell1426 4.946296e+00 0.8744777
+#> Cell1125 2.783757e+00 0.8612944
+#> Cell749 -2.601269e+00 0.8284664
+#> Cell441 -1.330214e+00 0.8362150
+#> Cell487 -8.270616e+00 0.7939051
+#> Cell1219 1.951349e+00 0.8562199
+#> Cell1619 2.476559e+00 0.8594217
+#> Cell617 -1.178983e+00 0.8371369
+#> Cell636 -4.479972e+00 0.8170135
+#> Cell1118 4.381234e+00 0.8710330
+#> Cell895 -6.013831e+00 0.8076628
+#> Cell189 -2.193528e+00 0.8309521
+#> Cell1132 5.564067e+00 0.8782437
+#> Cell1644 4.927563e+00 0.8743635
+#> Cell905 -1.965606e+00 0.8323415
+#> Cell733 -2.432107e+00 0.8294976
+#> Cell811 -4.506181e+00 0.8168537
+#> Cell569 -2.367583e+00 0.8298910
+#> Cell670 -4.909241e+00 0.8143966
+#> Cell1096 8.955393e+00 0.8989178
+#> Cell940 -3.096028e+00 0.8254503
+#> Cell1846 2.936438e+00 0.8622252
+#> Cell1931 4.178638e+00 0.8697979
+#> Cell292 -3.776034e+00 0.8213048
+#> Cell638 -1.436608e+00 0.8355664
+#> Cell12 -5.199827e+00 0.8126251
+#> Cell1862 5.076202e+00 0.8752696
+#> Cell358 -4.409637e-01 0.8416360
+#> Cell1248 5.915112e+00 0.8803837
+#> Cell1688 3.246616e+00 0.8641161
+#> Cell340 -7.976478e-01 0.8394616
+#> Cell786 4.118249e-01 0.8468347
+#> Cell744 2.281988e+00 0.8582356
+#> Cell429 2.419126e+00 0.8590716
+#> Cell658 -3.870323e+00 0.8207300
+#> Cell1220 4.250463e+00 0.8702358
+#> Cell1472 8.179210e-01 0.8493104
+#> Cell787 -5.758319e+00 0.8092205
+#> Cell1745 3.718834e+00 0.8669948
+#> Cell1793 1.916956e+00 0.8560103
+#> Cell770 -2.023106e+00 0.8319910
+#> Cell1278 4.410278e+00 0.8712100
+#> Cell652 -9.557329e+00 0.7860610
+#> Cell1253 1.467654e+00 0.8532713
+#> Cell1481 2.346220e+00 0.8586272
+#> Cell1437 4.697112e+00 0.8729586
+#> Cell1562 8.895419e-01 0.8497470
+#> Cell829 -8.435264e+00 0.7929013
+#> Cell1213 2.961676e+00 0.8623791
+#> Cell695 -2.691013e+00 0.8279193
+#> Cell1256 4.848307e+00 0.8738803
+#> Cell947 -7.166447e+00 0.8006363
+#> Cell222 -2.560759e+00 0.8287133
+#> Cell747 -9.706699e+00 0.7851504
+#> Cell1100 1.667308e+00 0.8544884
+#> Cell846 -3.211294e+00 0.8247476
+#> Cell1134 2.105607e+00 0.8571603
+#> Cell659 -6.499558e+00 0.8047017
+#> Cell1432 3.135758e+00 0.8634403
+#> Cell368 1.999551e+00 0.8565138
+#> Cell1173 5.811540e+00 0.8797523
+#> Cell1080 4.900860e+00 0.8742007
+#> Cell176 -4.648930e+00 0.8159835
+#> Cell1783 3.091339e+00 0.8631695
+#> Cell1095 5.188361e+00 0.8759533
+#> Cell1000 -5.348555e+00 0.8117185
+#> Cell1676 2.616644e+00 0.8602757
+#> Cell1207 4.214877e+00 0.8700188
+#> Cell1470 4.120203e+00 0.8694417
+#> Cell933 -2.774783e+00 0.8274086
+#> Cell173 -7.446718e+00 0.7989277
+#> Cell1742 3.337452e+00 0.8646699
+#> Cell1015 2.838582e+00 0.8616287
+#> Cell1209 3.433913e+00 0.8652579
+#> Cell731 -1.186691e+01 0.7719814
+#> Cell972 1.876529e-01 0.8454681
+#> Cell511 -2.155100e+00 0.8311863
+#> Cell588 -1.530208e+00 0.8349958
+#> Cell1717 1.495559e+00 0.8534414
+#> Cell510 7.657879e-01 0.8489926
+#> Cell1908 1.557931e+00 0.8538216
+#> Cell78 -2.645891e+00 0.8281944
+#> Cell892 6.109130e-02 0.8446966
+#> Cell331 -7.465589e+00 0.7988126
+#> Cell433 -1.985159e+00 0.8322223
+#> Cell865 -1.093210e+00 0.8376598
+#> Cell651 -4.463854e+00 0.8171117
+#> Cell508 -1.324912e+00 0.8362473
+#> Cell1634 3.256197e+00 0.8641745
+#> Cell1271 4.817588e+00 0.8736930
+#> Cell281 -6.187340e+00 0.8066051
+#> Cell481 -5.465691e+00 0.8110044
+#> Cell542 -4.100632e+00 0.8193260
+#> Cell1825 5.698393e+00 0.8790626
+#> Cell1149 2.027099e+00 0.8566817
+#> Cell571 -3.834967e+00 0.8209456
+#> Cell490 -5.571305e+00 0.8103605
+#> Cell501 -2.930850e+00 0.8264572
+#> Cell427 -4.258967e+00 0.8183608
+#> Cell576 -1.821674e+00 0.8332189
+#> Cell776 1.245329e+00 0.8519159
+#> Cell1458 6.134507e-01 0.8480639
+#> Cell416 -4.414481e+00 0.8174127
+#> Cell1696 3.058324e+00 0.8629683
+#> Cell906 -6.802976e+00 0.8028520
+#> Cell1819 3.406465e+00 0.8650906
+#> Cell282 -1.857299e-01 0.8431919
+#> Cell1857 3.677443e+00 0.8667425
+#> Cell961 -2.209400e+00 0.8308553
+#> Cell361 -5.240672e+00 0.8123761
+#> Cell318 -3.061130e+00 0.8256630
+#> Cell167 -4.038965e+00 0.8197019
+#> Cell1812 2.598353e+00 0.8601642
+#> Cell900 -5.003189e+00 0.8138239
+#> Cell717 -6.758335e+00 0.8031242
+#> Cell1392 5.742891e+00 0.8793339
+#> Cell326 -1.826587e+01 0.7329722
+#> Cell1811 4.128182e+00 0.8694903
+#> Cell1595 2.197876e+00 0.8577228
+#> Cell351 -1.856948e+00 0.8330039
+#> Cell328 -4.637247e+00 0.8160547
+#> Cell1396 3.138848e+00 0.8634591
+#> Cell438 4.807430e-01 0.8472549
+#> Cell80 -2.002775e+00 0.8321149
+#> Cell333 -4.508183e+00 0.8168415
+#> Cell461 -4.353326e+00 0.8177855
+#> Cell1162 1.527596e+01 0.9374491
+#> Cell1594 3.303991e+00 0.8644659
+#> Cell975 -2.440686e+00 0.8294453
+#> Cell1081 3.877699e+00 0.8679633
+#> Cell1358 7.441887e+00 0.8896912
+#> Cell444 -5.354372e+00 0.8116830
+#> Cell119 -4.197567e+00 0.8187351
+#> Cell1614 2.392537e+00 0.8589095
+#> Cell1456 2.282547e+00 0.8582390
+#> Cell1737 3.209152e+00 0.8638877
+#> Cell1073 3.191203e+00 0.8637783
+#> Cell1877 3.841473e+00 0.8677425
+#> Cell1959 5.046189e+00 0.8750866
+#> Cell605 -7.352027e-01 0.8398423
+#> Cell155 -4.675026e+00 0.8158244
+#> Cell1636 4.718995e-02 0.8446119
+#> Cell1555 3.980262e+00 0.8685886
+#> Cell690 -6.075248e+00 0.8072884
+#> Cell25 -2.278224e+00 0.8304357
+#> Cell1775 1.915576e+00 0.8560019
+#> Cell140 -3.687203e+00 0.8218463
+#> Cell1218 3.214863e+00 0.8639226
+#> Cell1482 2.369019e+00 0.8587661
+#> Cell1229 3.527793e+00 0.8658302
+#> Cell1730 2.712156e+00 0.8608580
+#> Cell1289 2.195212e+00 0.8577066
+#> Cell1447 3.794372e+00 0.8674553
+#> Cell216 -3.843653e+00 0.8208926
+#> Cell1257 3.655495e+00 0.8666087
+#> Cell1566 1.259520e+00 0.8520024
+#> Cell988 -3.946715e-01 0.8419182
+#> Cell1839 3.499144e+00 0.8656556
+#> Cell1543 4.527436e+00 0.8719242
+#> Cell352 -6.976907e+00 0.8017917
+#> Cell1759 5.097751e+00 0.8754010
+#> Cell147 -7.986963e+00 0.7956343
+#> Cell544 -2.414924e+00 0.8296024
+#> Cell419 -4.062967e+00 0.8195556
+#> Cell1757 4.887216e+00 0.8741175
+#> Cell1797 3.839514e+00 0.8677305
+#> Cell280 -2.240158e+00 0.8306678
+#> Cell531 -8.479710e+00 0.7926304
+#> Cell1381 5.509834e+00 0.8779131
+#> Cell29 -5.015415e+00 0.8137493
+#> Cell214 -4.912004e+00 0.8143797
+#> Cell1305 3.799995e+00 0.8674896
+#> Cell705 -1.264260e+00 0.8366170
+#> Cell1883 3.057634e+00 0.8629641
+#> Cell1509 1.553197e+00 0.8537927
+#> Cell1486 5.961691e+00 0.8806677
+#> Cell1692 6.580177e+00 0.8844381
+#> Cell59 -2.394602e+00 0.8297263
+#> Cell262 5.023204e+00 0.8749465
+#> Cell72 -2.631286e+00 0.8282834
+#> Cell21 -6.450240e+00 0.8050024
+#> Cell1413 4.485221e+00 0.8716669
+#> Cell338 -1.514700e+01 0.7519854
+#> Cell1796 3.494890e+00 0.8656296
+#> Cell1710 1.439352e+00 0.8530987
+#> Cell889 -3.710333e+00 0.8217053
+#> Cell1526 5.918066e+00 0.8804017
+#> Cell566 -4.678836e+00 0.8158012
+#> Cell283 -3.498849e+00 0.8229946
+#> Cell1326 7.322040e+00 0.8889606
+#> Cell1239 4.381677e+00 0.8710357
+#> Cell1277 4.259180e-01 0.8469207
+#> Cell850 -5.714969e+00 0.8094847
+#> Cell1304 1.633186e+00 0.8542804
+#> Cell231 -6.066028e+00 0.8073446
+#> Cell137 1.006406e-01 0.8449377
+#> Cell1301 2.082097e+00 0.8570170
+#> Cell274 -5.501316e+00 0.8107872
+#> Cell560 -2.784770e+00 0.8273477
+#> Cell880 -1.551019e+01 0.7497714
+#> Cell687 -7.574809e+00 0.7981468
+#> Cell1097 4.557561e+00 0.8721079
+#> Cell219 -6.825235e+00 0.8027164
+#> Cell428 1.654634e+00 0.8544111
+#> Cell121 -5.873043e+00 0.8085211
+#> Cell759 -4.836695e+00 0.8148388
+#> Cell332 5.754681e-01 0.8478323
+#> Cell1950 4.048628e+00 0.8690053
+#> Cell1423 3.268933e+00 0.8642522
+#> Cell1672 2.969972e+00 0.8624297
+#> Cell1933 2.140840e+00 0.8573751
+#> Cell307 -3.730342e+00 0.8215834
+#> Cell607 -1.614551e+00 0.8344816
+#> Cell1928 2.186463e+00 0.8576532
+#> Cell813 -9.242206e-01 0.8386900
+#> Cell1009 3.415880e+00 0.8651480
+#> Cell935 -6.498383e+00 0.8047089
+#> Cell1052 2.397818e+00 0.8589417
+#> Cell107 -2.091316e+00 0.8315752
+#> Cell91 -6.143081e+00 0.8068749
+#> Cell872 -3.837571e+00 0.8209297
+#> Cell827 -2.599654e+00 0.8284762
+#> Cell1785 3.484115e+00 0.8655640
+#> Cell204 -4.073165e+00 0.8194935
+#> Cell767 -2.521967e+00 0.8289498
+#> Cell1963 8.464207e-01 0.8494841
+#> Cell750 -3.388674e+00 0.8236662
+#> Cell359 -1.650923e+00 0.8342599
+#> Cell1436 3.045643e+00 0.8628910
+#> Cell1325 4.851375e+00 0.8738990
+#> Cell1550 5.102071e+00 0.8754273
+#> Cell1066 3.789751e+00 0.8674272
+#> Cell1452 2.978715e+00 0.8624829
+#> Cell1475 2.560437e+00 0.8599331
+#> Cell669 -8.142511e+00 0.7946860
+#> Cell466 -3.171648e+00 0.8249893
+#> Cell1387 1.290024e+00 0.8521884
+#> Cell1255 2.319424e+00 0.8584638
+#> Cell564 -5.331259e+00 0.8118239
+#> Cell1148 4.714649e+00 0.8730655
+#> Cell1655 4.792272e+00 0.8735387
+#> Cell1117 3.183319e+00 0.8637303
+#> Cell169 -2.921310e+00 0.8265154
+#> Cell296 -2.316182e-01 0.8429122
+#> Cell229 -5.889071e+00 0.8084234
+#> Cell505 6.657080e-01 0.8483825
+#> Cell745 -6.593013e-01 0.8403050
+#> Cell53 -3.020890e+00 0.8259083
+#> Cell161 -7.415454e+00 0.7991183
+#> Cell277 -8.239001e+00 0.7940978
+#> Cell258 -1.938742e+00 0.8325053
+#> Cell195 -7.220083e+00 0.8003093
+#> Cell1571 1.297414e+00 0.8522334
+#> Cell1340 3.891764e+00 0.8680491
+#> Cell598 -3.115143e+00 0.8253337
+#> Cell440 -3.629724e-01 0.8421114
+#> Cell405 -3.118424e+00 0.8253137
+#> Cell1300 1.603117e+00 0.8540971
+#> Cell1018 1.948847e+00 0.8562047
+#> Cell574 -4.716389e+00 0.8155722
+#> Cell226 -4.693817e+00 0.8157099
+#> Cell1174 2.068747e+00 0.8569356
+#> Cell582 -4.669245e+00 0.8158596
+#> Cell526 -2.282387e+00 0.8304104
+#> Cell595 -2.082865e-03 0.8443115
+#> Cell225 -2.907184e+00 0.8266015
+#> Cell896 -6.381066e-01 0.8404342
+#> Cell220 -5.370176e+00 0.8115866
+#> Cell105 -3.506897e+00 0.8229455
+#> Cell120 -4.165303e-01 0.8417849
+#> Cell1973 4.555069e+00 0.8720927
+#> Cell711 -5.373539e+00 0.8115662
+#> Cell1515 7.026531e+00 0.8871591
+#> Cell1984 3.203246e-01 0.8462769
+#> Cell618 -6.033430e+00 0.8075433
+#> Cell1418 5.178101e+00 0.8758908
+#> Cell1896 5.243042e+00 0.8762867
+#> Cell1569 4.048764e+00 0.8690062
+#> Cell503 -1.910114e+00 0.8326798
+#> Cell1615 4.125922e+00 0.8694765
+#> Cell1201 4.967158e+00 0.8746048
+#> Cell1312 4.927209e+00 0.8743613
+#> Cell1821 5.096821e-01 0.8474313
+#> Cell864 -6.103643e-01 0.8406033
+#> Cell1891 4.502614e+00 0.8717729
+#> Cell430 -1.864689e+00 0.8329567
+#> Cell680 -7.498379e-01 0.8397530
+#> Cell1351 3.262226e+00 0.8642113
+#> Cell1953 2.223310e+00 0.8578779
+#> Cell380 -1.936683e+00 0.8325178
+#> Cell1050 3.437410e+00 0.8652792
+#> Cell1648 4.934439e+00 0.8744054
+#> Cell1893 2.043078e+00 0.8567791
+#> Cell1110 2.231037e+00 0.8579250
+#> Cell539 -6.001406e+00 0.8077386
+#> Cell111 -3.382416e+00 0.8237044
+#> Cell1850 6.015278e+00 0.8809944
+#> Cell1972 6.007107e+00 0.8809446
+#> Cell1153 2.156118e+00 0.8574683
+#> Cell95 -7.269256e+00 0.8000095
+#> Cell463 6.269076e-01 0.8481459
+#> Cell1674 2.133560e+00 0.8573307
+#> Cell235 -2.812617e+00 0.8271780
+#> Cell365 -7.569925e+00 0.7981766
+#> Cell843 9.370951e-02 0.8448955
+#> Cell272 -5.144375e+00 0.8129632
+#> Cell803 -5.202824e+00 0.8126069
+#> Cell1402 1.490359e+00 0.8534097
+#> Cell1925 7.658634e-01 0.8489930
+#> Cell1772 4.911765e+00 0.8742672
+#> Cell215 -4.442662e+00 0.8172409
+#> Cell1430 3.143584e+00 0.8634880
+#> Cell515 3.017874e-01 0.8461639
+#> Cell1878 6.958891e+00 0.8867468
+#> Cell657 -5.234652e+00 0.8124128
+#> Cell1450 3.102892e+00 0.8632400
+#> Cell1751 3.052342e+00 0.8629318
+#> Cell363 -2.497784e+00 0.8290973
+#> Cell631 -8.340916e+00 0.7934765
+#> Cell804 1.329239e+00 0.8524275
+#> Cell1433 3.873284e+00 0.8679364
+#> Cell685 -6.945614e+00 0.8019825
+#> Cell608 -3.181663e+00 0.8249282
+#> Cell1841 3.308432e+00 0.8644930
+#> Cell371 -3.629258e+00 0.8221996
+#> Cell964 -4.188391e+00 0.8187910
+#> Cell370 -4.745255e+00 0.8153963
+#> Cell858 -2.145241e-01 0.8430164
+#> Cell1465 3.586194e+00 0.8661862
+#> Cell903 -8.937069e-01 0.8388760
+#> Cell400 1.193809e+00 0.8516018
+#> Cell718 2.008210e+00 0.8565666
+#> Cell1382 1.110675e+01 0.9120329
+#> Cell1700 2.897870e+00 0.8619901
+#> Cell801 -8.605064e+00 0.7918662
+#> Cell1988 5.251090e+00 0.8763357
+#> Cell1294 1.138340e+00 0.8512637
+#> Cell398 -7.584313e+00 0.7980889
+#> Cell1457 3.443685e+00 0.8653175
+#> Cell852 -1.841001e+00 0.8331011
+#> Cell1670 8.579196e-01 0.8495542
+#> Cell1283 1.696793e+00 0.8546681
+#> Cell1967 5.426420e+00 0.8774046
+#> Cell1288 7.200561e+00 0.8882201
+#> Cell861 -7.638791e+00 0.7977568
+#> Cell516 -5.894441e+00 0.8083906
+#> Cell1435 3.261256e+00 0.8642054
+#> Cell1769 5.885843e+00 0.8802053
+#> Cell774 -9.726718e+00 0.7850284
+#> Cell1905 4.992353e+00 0.8747584
+#> Cell468 -9.778891e+00 0.7847104
+#> Cell1323 5.078190e+00 0.8752817
+#> Cell1887 3.564311e+00 0.8660528
+#> Cell1090 2.802675e+00 0.8614098
+#> Cell664 -3.982899e+00 0.8200437
+#> Cell1520 7.467828e+00 0.8898494
+#> Cell1572 4.304011e+00 0.8705622
+#> Cell837 -1.144457e+00 0.8373474
+#> Cell36 1.710862e+00 0.8547539
+#> Cell1298 1.949619e+00 0.8562094
+#> Cell50 -4.688545e+00 0.8157420
+#> Cell1580 2.893457e+00 0.8619632
+#> Cell1130 3.194021e+00 0.8637955
+#> Cell1027 2.877252e+00 0.8618644
+#> Cell1682 3.398665e+00 0.8650430
+#> Cell1057 3.508827e+00 0.8657146
+#> Cell1205 4.906683e+00 0.8742362
+#> Cell1114 4.140353e+00 0.8695645
+#> Cell1354 6.044346e+00 0.8811716
+#> Cell1448 5.351289e+00 0.8769466
+#> Cell1467 3.706975e+00 0.8669225
+#> Cell1823 4.315766e+00 0.8706338
+#> Cell663 -3.892971e+00 0.8205919
+#> Cell1105 4.871124e+00 0.8740194
+#> Cell350 -5.856891e+00 0.8086195
+#> Cell1394 4.368809e+00 0.8709572
+#> Cell246 -1.865186e+00 0.8329537
+#> Cell1055 5.991891e+00 0.8808518
+#> Cell1065 3.442988e+00 0.8653132
+#> Cell1744 6.303191e+00 0.8827495
+#> Cell182 -2.299216e+00 0.8303078
+#> Cell287 1.351415e+00 0.8525626
+#> Cell1196 1.443416e+00 0.8531235
+#> Cell275 -9.659975e+00 0.7854353
+#> Cell1616 7.444284e+00 0.8897058
+#> Cell1851 3.474343e+00 0.8655044
+#> Cell649 -2.486285e+00 0.8291674
+#> Cell312 -1.341652e+00 0.8361452
+#> Cell1042 4.025797e+00 0.8688661
+#> Cell152 -2.332458e+00 0.8301051
+#> Cell1901 2.630160e+00 0.8603581
+#> Cell1695 6.045114e+00 0.8811763
+#> Cell1917 4.764196e+00 0.8733676
+#> Cell1089 4.416587e+00 0.8712485
+#> Cell764 -2.943015e+00 0.8263831
+#> Cell1356 1.356056e+00 0.8525909
+#> Cell1556 2.952237e+00 0.8623215
+#> Cell1455 3.346602e+00 0.8647257
+#> Cell1362 7.477613e+00 0.8899090
+#> Cell1403 3.422879e+00 0.8651906
+#> Cell1898 8.128245e+00 0.8938754
+#> Cell1584 3.302191e+00 0.8644549
+#> Cell924 8.197529e-01 0.8493215
+#> Cell1188 2.790112e+00 0.8613332
+#> Cell146 3.860961e-01 0.8466779
+#> Cell376 -5.534698e+00 0.8105837
+#> Cell1804 3.630532e+00 0.8664565
+#> Cell103 -2.346748e+00 0.8300180
+#> Cell766 -5.119777e-01 0.8412031
+#> Cell435 -4.820987e+00 0.8149346
+#> Cell1888 1.645193e+00 0.8543536
+#> Cell620 -1.380160e+01 0.7601872
+#> Cell1464 5.416359e+00 0.8773433
+#> Cell185 -3.840412e+00 0.8209124
+#> Cell645 -4.182135e-01 0.8417747
+#> Cell144 -3.332216e+00 0.8240104
+#> Cell610 -8.742003e+00 0.7910314
+#> Cell1091 2.801564e+00 0.8614030
+#> Cell1565 4.140734e+00 0.8695668
+#> Cell1059 3.939935e+00 0.8683427
+#> Cell563 -3.049525e+00 0.8257337
+#> Cell1072 1.574722e+01 0.9403220
+#> Cell845 -5.302509e+00 0.8119992
+#> Cell54 4.776956e-01 0.8472363
+#> Cell133 1.620048e+00 0.8542003
+#> Cell960 -6.667556e-01 0.8402595
+#> Cell303 -3.304544e+00 0.8241791
+#> Cell1143 1.242507e+00 0.8518987
+#> Cell1129 5.002102e+00 0.8748179
+#> Cell1380 1.748233e+00 0.8549817
+#> Cell1554 4.014637e+00 0.8687981
+#> Cell1690 4.916968e+00 0.8742989
+#> Cell1191 6.697021e+00 0.8851504
+#> Cell1496 3.548517e+00 0.8659566
+#> Cell1026 5.000829e+00 0.8748101
+#> Cell816 -2.035782e+00 0.8319137
+#> Cell694 1.443715e+00 0.8531253
+#> Cell1786 2.360793e+00 0.8587160
+#> Cell323 -1.126546e+00 0.8374566
+#> Cell243 -2.878180e+00 0.8267783
+#> Cell1459 2.910312e+00 0.8620660
+#> Cell1795 3.638052e+00 0.8665024
+#> Cell1025 2.697773e+00 0.8607703
+#> Cell1341 6.737708e+00 0.8853984
+#> Cell783 -2.020711e+00 0.8320056
+#> Cell1078 5.815489e+00 0.8797764
+#> Cell1460 1.235202e-01 0.8450772
+#> Cell831 5.123096e-01 0.8474473
+#> Cell232 -2.440265e+00 0.8294479
+#> Cell1938 6.172342e+00 0.8819519
+#> Cell1628 4.043549e+00 0.8689744
+#> Cell1156 2.282823e+00 0.8582407
+#> Cell1532 6.069629e+00 0.8813257
+#> Cell1560 2.120105e+00 0.8572487
+#> Cell948 -2.735137e+00 0.8276503
+#> Cell1523 3.532187e+00 0.8658570
+#> Cell1915 5.009858e+00 0.8748652
+#> Cell1318 3.504385e-01 0.8464605
+#> Cell661 -2.563705e+00 0.8286954
+#> Cell122 -6.903038e+00 0.8022421
+#> Cell592 -5.602448e+00 0.8101707
+#> Cell139 -1.223010e+00 0.8368685
+#> Cell1484 1.537295e+00 0.8536958
+#> Cell1697 3.587075e+00 0.8661916
+#> Cell1371 3.616565e+00 0.8663714
+#> Cell247 -1.183339e+00 0.8371103
+#> Cell1637 4.470325e+00 0.8715761
+#> Cell550 -9.182961e+00 0.7883432
+#> Cell1606 3.894338e+00 0.8680647
+#> Cell403 -5.153906e+00 0.8129051
+#> Cell1168 3.653922e+00 0.8665991
+#> Cell79 -2.924591e+00 0.8264954
+#> Cell1552 1.916419e+00 0.8560070
+#> Cell1190 3.784759e+00 0.8673967
+#> Cell128 -3.894451e+00 0.8205829
+#> Cell1016 2.199875e+00 0.8577350
+#> Cell1427 4.329922e+00 0.8707201
+#> Cell1193 3.123494e+00 0.8633655
+#> Cell423 8.177897e-01 0.8493096
+#> Cell1285 2.182494e+00 0.8576290
+#> Cell708 -4.752708e+00 0.8153508
+#> Cell974 -2.371104e+00 0.8298695
+#> Cell410 5.175616e-01 0.8474793
+#> Cell1701 5.709354e+00 0.8791294
+#> Cell676 -4.582072e+00 0.8163911
+#> Cell1668 4.751542e+00 0.8732904
+#> Cell665 -1.995468e+00 0.8321595
+#> Cell61 -9.139995e+00 0.7886052
+#> Cell1721 6.592624e+00 0.8845140
+#> Cell1062 7.118597e+00 0.8877204
+#> Cell946 -6.905567e-02 0.8439032
+#> Cell1039 6.053066e+00 0.8812247
+#> Cell2 -3.233870e+00 0.8246099
+#> Cell678 -9.490204e+00 0.7864702
+#> Cell253 -3.692694e+00 0.8218129
+#> Cell1865 2.759221e+00 0.8611449
+#> Cell715 -4.774183e+00 0.8152199
+#> Cell943 -6.044608e+00 0.8074752
+#> Cell1098 6.449359e+00 0.8836406
+#> Cell716 1.983220e+00 0.8564142
+#> Cell1013 3.611431e+00 0.8663401
+#> Cell1848 5.072667e+00 0.8752480
+#> Cell202 -4.655746e+00 0.8159419
+
+LoadPathway.RdThis function reads pathway data from the package's built-in Excel file.
+LoadPathway(pathway)A data frame with pathway data.
+LoadPathway("Wnt")
+#> # A tibble: 18 × 4
+#> Molecules Coefficients Notes Ref
+#> <chr> <dbl> <lgl> <chr>
+#> 1 Lgr5 1 NA https://www.ncbi.nlm.nih.gov/pmc/articles/PMC55…
+#> 2 Rnf43 1 NA NA
+#> 3 Lrp5 1 NA NA
+#> 4 Lrp6 1 NA NA
+#> 5 Fzd6 1 NA NA
+#> 6 Ctnnb1 1 NA NA
+#> 7 Gsk3b 1 NA NA
+#> 8 Ccnd1 1 NA NA
+#> 9 Axin2 1 NA NA
+#> 10 Myc 1 NA NA
+#> 11 Lef1 1 NA NA
+#> 12 Tcf7 1 NA NA
+#> 13 Tcf7l1 1 NA NA
+#> 14 Tcf7l2 1 NA NA
+#> 15 Tle1 1 NA NA
+#> 16 Apc 1 NA NA
+#> 17 Csnk1a1 1 NA NA
+#> 18 Dvl1 -1 NA NA
+PathwayMaxMin.RdA function to obtain the hypothetical max and min activation status of selected pathway for a given scRNA seq data set
+PathwayMaxMin(x, pathway, scale.data = TRUE)The hypothetical value for Pathway on and off (max and min value for features)
+data(fake_test_object) # load the fake test data
+PathwayMaxMin(fake_test_object, "Wnt")
+#> Centering and scaling data matrix
+#> pathway.on pathway.off
+#> Lgr5 1.851647 -11.600077
+#> Rnf43 1.479722 -9.998238
+#> Lrp5 1.880735 -7.935503
+#> Lrp6 1.635447 -7.746165
+#> Fzd6 1.873864 -8.215280
+#> Ctnnb1 1.896552 -8.294299
+#> Gsk3b 1.981532 -11.693745
+#> Ccnd1 1.975098 -13.129679
+#> Axin2 1.994353 -13.235483
+#> Myc 1.685388 -11.679067
+#> Lef1 1.596498 -10.771246
+#> Tcf7 1.595631 -10.436295
+#> Tcf7l1 1.497348 -9.843343
+#> Tcf7l2 1.716832 -11.026494
+#> Tle1 1.891611 -12.632374
+#> Apc 1.944771 -8.883710
+#> Csnk1a1 1.808021 -8.091854
+#> Dvl1 -8.132137 2.135900
+PlotPathway.RdA function to plot the Pathway activation status
+PlotPathway(to.plot, pathway, group, color)A ggplot object.
+PreparePlotData.RdA function to prepare the signal transduction dataframe for plotting
+PreparePlotData(x, final_mds, group)data for plotting
+data(fake_test_object)
+data(fake_final_mds)
+PreparePlotData(fake_test_object, fake_final_mds, "genotype")
+#> V1 normalized genotype scale
+#> Cell819 -1.361697687 0.8360230 WT -0.3147161622
+#> Cell124 -4.866033576 0.8146600 WT -1.0923828770
+#> Cell1363 3.284125686 0.8643448 Mutant 0.7162644044
+#> Cell1460 0.123520244 0.8450772 Mutant 0.0148768295
+#> Cell117 -1.495637744 0.8352065 WT -0.3444395469
+#> Cell1294 1.138340435 0.8512637 Mutant 0.2400812360
+#> Cell606 -5.761865732 0.8091988 WT -1.2911819852
+#> Cell415 -3.688227594 0.8218401 WT -0.8310093849
+#> Cell787 -5.758319247 0.8092205 WT -1.2903949649
+#> Cell210 -2.274698672 0.8304572 WT -0.5173253010
+#> Cell1711 3.876811312 0.8679579 Mutant 0.8477905761
+#> Cell1193 3.123493564 0.8633655 Mutant 0.6806176346
+#> Cell361 -5.240672023 0.8123761 WT -1.1755209834
+#> Cell1048 1.228167834 0.8518113 Mutant 0.2600153349
+#> Cell1101 2.726820445 0.8609474 Mutant 0.5925896912
+#> Cell1274 7.028436740 0.8871708 Mutant 1.5471853459
+#> Cell1125 2.783756541 0.8612944 Mutant 0.6052246976
+#> Cell1576 5.132836077 0.8756148 Mutant 1.1265220343
+#> Cell982 -2.161525113 0.8311471 WT -0.4922103254
+#> Cell1226 2.511031131 0.8596319 Mutant 0.5447026815
+#> Cell854 -0.559051825 0.8409161 WT -0.1365965440
+#> Cell40 -4.673461680 0.8158339 WT -1.0496481738
+#> Cell973 -3.095113108 0.8254558 WT -0.6993880425
+#> Cell518 -5.928802583 0.8081812 WT -1.3282278725
+#> Cell1991 3.531548268 0.8658531 Mutant 0.7711713289
+#> Cell1655 4.792272135 0.8735387 Mutant 1.0509455912
+#> Cell1971 -0.102871913 0.8436971 Mutant -0.0353631162
+#> Cell128 -3.894451401 0.8205829 WT -0.8767736596
+#> Cell768 0.997244490 0.8504036 WT 0.2087698482
+#> Cell1106 5.098449379 0.8754052 Mutant 1.1188910904
+#> Cell1472 0.817921009 0.8493104 Mutant 0.1689751747
+#> Cell365 -7.569925269 0.7981766 WT -1.6924185575
+#> Cell452 0.636914829 0.8482069 WT 0.1288070840
+#> Cell1273 1.586153260 0.8539936 Mutant 0.3394578767
+#> Cell1936 3.466919616 0.8654591 Mutant 0.7568292245
+#> Cell1325 4.851375323 0.8738990 Mutant 1.0640615092
+#> Cell340 -0.797647803 0.8394616 WT -0.1895447077
+#> Cell1187 2.211473303 0.8578057 Mutant 0.4782261337
+#> Cell1496 3.548517245 0.8659566 Mutant 0.7749370092
+#> Cell157 -3.143330309 0.8251619 WT -0.7100881904
+#> Cell310 -1.391485728 0.8358414 WT -0.3213265924
+#> Cell829 -8.435264399 0.7929013 WT -1.8844507883
+#> Cell1391 2.796244201 0.8613706 Mutant 0.6079959039
+#> Cell949 -6.211385893 0.8064585 WT -1.3909375104
+#> Cell1731 3.162725566 0.8636047 Mutant 0.6893238269
+#> Cell398 -7.584312587 0.7980889 WT -1.6956113274
+#> Cell951 -4.708977282 0.8156174 WT -1.0575296392
+#> Cell471 0.088344814 0.8448627 WT 0.0070708536
+#> Cell1884 2.920808547 0.8621299 Mutant 0.6356386725
+#> Cell18 -4.235923057 0.8185013 WT -0.9525515387
+#> Cell1743 4.683413344 0.8728751 Mutant 1.0267881299
+#> Cell737 -0.384585902 0.8419797 WT -0.0978798383
+#> Cell145 -3.842298695 0.8209009 WT -0.8652001619
+#> Cell1144 1.532098968 0.8536641 Mutant 0.3274623874
+#> Cell1648 4.934439486 0.8744054 Mutant 1.0824947408
+#> Cell1031 5.056764874 0.8751511 Mutant 1.1096406495
+#> Cell49 -2.564632675 0.8286897 WT -0.5816661720
+#> Cell1574 5.900179299 0.8802927 Mutant 1.2968074468
+#> Cell229 -5.889071205 0.8084234 WT -1.3194108609
+#> Cell626 -3.901158602 0.8205420 WT -0.8782620921
+#> Cell965 -0.048221456 0.8440302 WT -0.0232353287
+#> Cell94 -2.922874788 0.8265058 WT -0.6611656765
+#> Cell110 -0.384174046 0.8419822 WT -0.0977884411
+#> Cell916 -7.622405495 0.7978567 WT -1.7040647371
+#> Cell61 -9.139994794 0.7886052 WT -2.0408414394
+#> Cell1697 3.587075369 0.8661916 Mutant 0.7834936574
+#> Cell190 -2.002755068 0.8321150 WT -0.4569767797
+#> Cell1364 5.600513823 0.8784659 Mutant 1.2303070103
+#> Cell890 1.133066567 0.8512316 WT 0.2389108824
+#> Cell1119 5.987505139 0.8808251 Mutant 1.3161864108
+#> Cell1157 4.395225667 0.8711182 Mutant 0.9628347958
+#> Cell700 -7.229416255 0.8002524 WT -1.6168543037
+#> Cell1613 6.837192624 0.8860049 Mutant 1.5047452980
+#> Cell354 -1.777760668 0.8334866 WT -0.4070470180
+#> Cell1023 3.233407146 0.8640356 Mutant 0.7050091703
+#> Cell749 -2.601269135 0.8284664 WT -0.5897963731
+#> Cell232 -2.440264740 0.8294479 WT -0.5540669902
+#> Cell807 -6.101310484 0.8071295 WT -1.3665100626
+#> Cell550 -9.182960894 0.7883432 WT -2.0503762861
+#> Cell148 -5.132085142 0.8130381 WT -1.1514238633
+#> Cell1051 3.635022305 0.8664839 Mutant 0.7941338295
+#> Cell335 -1.024197509 0.8380805 WT -0.2398196161
+#> Cell1173 5.811539565 0.8797523 Mutant 1.2771369092
+#> Cell1206 3.879334852 0.8679733 Mutant 0.8483505887
+#> Cell1429 3.684289423 0.8667843 Mutant 0.8050669702
+#> Cell22 -2.336216569 0.8300822 WT -0.5309770804
+#> Cell1997 3.814125316 0.8675758 Mutant 0.8338795770
+#> Cell102 -2.228032892 0.8307417 WT -0.5069694376
+#> Cell429 2.419125800 0.8590716 WT 0.5243074570
+#> Cell104 -5.555988977 0.8104539 WT -1.2454947267
+#> Cell100 -2.825999118 0.8270964 WT -0.6396674566
+#> Cell980 -1.941271131 0.8324899 WT -0.4433325364
+#> Cell59 -2.394602050 0.8297263 WT -0.5439337280
+#> Cell840 -4.835286111 0.8148474 WT -1.0855595356
+#> Cell676 -4.582072394 0.8163911 WT -1.0293674678
+#> Cell346 -9.100277862 0.7888473 WT -2.0320276336
+#> Cell1445 4.173118022 0.8697642 Mutant 0.9135456501
+#> Cell107 -2.091316118 0.8315752 WT -0.4766298560
+#> Cell1775 1.915576101 0.8560019 Mutant 0.4125619360
+#> Cell295 -1.396819951 0.8358089 WT -0.3225103396
+#> Cell1488 2.123955227 0.8572722 Mutant 0.4588045094
+#> Cell1465 3.586193683 0.8661862 Mutant 0.7832979976
+#> Cell1182 2.487085077 0.8594859 Mutant 0.5393886791
+#> Cell1297 -0.817225971 0.8393422 Mutant -0.1938894081
+#> Cell1446 6.314464277 0.8828183 Mutant 1.3887437361
+#> Cell417 -3.302960491 0.8241888 WT -0.7455126141
+#> Cell1024 3.575678466 0.8661221 Mutant 0.7809645073
+#> Cell293 -3.756013138 0.8214269 WT -0.8460520529
+#> Cell533 -8.081572479 0.7950575 WT -1.8059610425
+#> Cell30 -3.949773029 0.8202457 WT -0.8890503906
+#> Cell1869 3.000673665 0.8626168 Mutant 0.6533619861
+#> Cell1421 4.339233195 0.8707769 Mutant 0.9504091943
+#> Cell1984 0.320324635 0.8462769 Mutant 0.0585507891
+#> Cell486 -3.492257897 0.8230348 WT -0.7875206569
+#> Cell1632 1.683145163 0.8545849 Mutant 0.3609818906
+#> Cell975 -2.440686321 0.8294453 WT -0.5541605455
+#> Cell753 -10.580639455 0.7798228 WT -2.3605429280
+#> Cell790 2.133719973 0.8573317 WT 0.4609714587
+#> Cell1171 5.107750506 0.8754619 Mutant 1.1209551553
+#> Cell1370 4.733619777 0.8731812 Mutant 1.0379297194
+#> Cell1302 1.834924197 0.8555102 Mutant 0.3946640222
+#> Cell782 -2.202498308 0.8308974 WT -0.5013029157
+#> Cell201 -1.587512083 0.8346464 WT -0.3648278938
+#> Cell1216 3.260351862 0.8641999 Mutant 0.7109886225
+#> Cell645 -0.418213463 0.8417747 WT -0.1053423178
+#> Cell28 -1.225058159 0.8368560 WT -0.2843937227
+#> Cell1487 4.147450170 0.8696078 Mutant 0.9078495540
+#> Cell1244 0.773216622 0.8490378 Mutant 0.1590545749
+#> Cell828 -2.404265102 0.8296674 WT -0.5460781098
+#> Cell144 -3.332216147 0.8240104 WT -0.7520048998
+#> Cell884 -1.040785277 0.8379794 WT -0.2435007002
+#> Cell1148 4.714648502 0.8730655 Mutant 1.0337196980
+#> Cell1345 2.035759316 0.8567345 Mutant 0.4392324632
+#> Cell1701 5.709353901 0.8791294 Mutant 1.2544603189
+#> Cell801 -8.605063906 0.7918662 WT -1.9221319435
+#> Cell508 -1.324912319 0.8362473 WT -0.3065529161
+#> Cell956 -6.024846252 0.8075957 WT -1.3495414587
+#> Cell1705 5.468638316 0.8776620 Mutant 1.2010417814
+#> Cell543 -3.521890162 0.8228541 WT -0.7940965179
+#> Cell1009 3.415879802 0.8651480 Mutant 0.7455026949
+#> Cell1096 8.955393404 0.8989178 Mutant 1.9748070425
+#> Cell1061 1.054412718 0.8507521 Mutant 0.2214563684
+#> Cell1479 3.519981229 0.8657826 Mutant 0.7686044228
+#> Cell962 -1.098184060 0.8376295 WT -0.2562383840
+#> Cell1741 3.331637954 0.8646344 Mutant 0.7268081167
+#> Cell1897 2.161410831 0.8575005 Mutant 0.4671164914
+#> Cell1620 0.267738847 0.8459564 Mutant 0.0468811837
+#> Cell834 -3.667926777 0.8219639 WT -0.8265043174
+#> Cell485 -5.101009901 0.8132275 WT -1.1445277833
+#> Cell1673 1.439939092 0.8531023 Mutant 0.3070106754
+#> Cell468 -9.778891135 0.7847104 WT -2.1826224883
+#> Cell778 -2.628158275 0.8283025 WT -0.5957634922
+#> Cell353 -10.835053614 0.7782718 WT -2.4170013925
+#> Cell565 -1.012065142 0.8381545 WT -0.2371272548
+#> Cell1738 5.516290041 0.8779525 Mutant 1.2116164414
+#> Cell91 -6.143080660 0.8068749 WT -1.3757795152
+#> Cell1185 3.646979025 0.8665568 Mutant 0.7967872119
+#> Cell1668 4.751542325 0.8732904 Mutant 1.0419070119
+#> Cell134 -2.864676052 0.8268606 WT -0.6482504707
+#> Cell691 -5.382384691 0.8115122 WT -1.2069692317
+#> Cell1733 2.251957209 0.8580525 Mutant 0.4872101429
+#> Cell327 -4.066606863 0.8195334 WT -0.9149776381
+#> Cell221 -5.022717035 0.8137048 WT -1.1271533769
+#> Cell1656 2.655234970 0.8605110 Mutant 0.5767037593
+#> Cell1671 4.161647504 0.8696943 Mutant 0.9110001635
+#> Cell769 -2.294245579 0.8303381 WT -0.5216630641
+#> Cell1145 1.761428015 0.8550622 Mutant 0.3783540747
+#> Cell808 3.138942580 0.8634597 WT 0.6840460120
+#> Cell1189 5.023361868 0.8749475 Mutant 1.1022280022
+#> Cell1524 7.513489287 0.8901277 Mutant 1.6548260610
+#> Cell837 -1.144457019 0.8373474 WT -0.2665070744
+#> Cell1002 4.523968849 0.8719031 Mutant 0.9914049131
+#> Cell1467 3.706974866 0.8669225 Mutant 0.8101012233
+#> Cell1279 4.008096495 0.8687582 Mutant 0.8769248029
+#> Cell581 -1.386549216 0.8358715 WT -0.3202311034
+#> Cell613 -6.936688074 0.8020369 WT -1.5518933612
+#> Cell1667 4.530619740 0.8719436 Mutant 0.9928808494
+#> Cell1459 2.910312012 0.8620660 Mutant 0.6333093277
+#> Cell196 -5.580251109 0.8103060 WT -1.2508788716
+#> Cell1381 5.509834329 0.8779131 Mutant 1.2101838182
+#> Cell1622 6.550178148 0.8842552 Mutant 1.4410523154
+#> Cell1983 6.504760982 0.8839783 Mutant 1.4309735388
+#> Cell1894 3.336180928 0.8646621 Mutant 0.7278162733
+#> Cell1405 3.858294669 0.8678450 Mutant 0.8436814445
+#> Cell1604 4.217865401 0.8700370 Mutant 0.9234757903
+#> Cell814 -7.718217741 0.7972726 WT -1.7253269666
+#> Cell455 -1.473736434 0.8353400 WT -0.3395793051
+#> Cell1612 3.825034723 0.8676423 Mutant 0.8363005444
+#> Cell1089 4.416587184 0.8712485 Mutant 0.9675752491
+#> Cell542 -4.100632256 0.8193260 WT -0.9225284026
+#> Cell1010 2.789917517 0.8613320 Mutant 0.6065919142
+#> Cell1122 2.808428978 0.8614449 Mutant 0.6106998958
+#> Cell1813 8.061320187 0.8934674 Mutant 1.7763982702
+#> Cell1651 3.300398615 0.8644440 Mutant 0.7198756207
+#> Cell736 -3.452738591 0.8232757 WT -0.7787507073
+#> Cell163 0.984616558 0.8503266 WT 0.2059675133
+#> Cell1521 3.146338992 0.8635048 Mutant 0.6856873909
+#> Cell936 -3.497309559 0.8230040 WT -0.7886416993
+#> Cell1436 3.045642779 0.8628910 Mutant 0.6633413327
+#> Cell306 -1.653313931 0.8342453 WT -0.3794303486
+#> Cell48 -2.005105615 0.8321007 WT -0.4574984027
+#> Cell597 0.287790289 0.8460786 WT 0.0513309111
+#> Cell1949 5.004020526 0.8748296 Mutant 1.0979358572
+#> Cell1021 4.769793259 0.8734017 Mutant 1.0459571786
+#> Cell9 -0.883859935 0.8389360 WT -0.2086765226
+#> Cell1688 3.246616189 0.8641161 Mutant 0.7079404628
+#> Cell478 5.231595783 0.8762169 WT 1.1484383513
+#> Cell908 -7.641382454 0.7977410 WT -1.7082760197
+#> Cell998 -3.556226529 0.8226448 WT -0.8017162925
+#> Cell1964 5.282284322 0.8765259 Mutant 1.1596869275
+#> Cell344 -5.460695917 0.8110348 WT -1.2243477125
+#> Cell1595 2.197875700 0.8577228 Mutant 0.4752086138
+#> Cell423 0.817789660 0.8493096 WT 0.1689460264
+#> Cell1598 10.613845114 0.9090280 Mutant 2.3428433079
+#> Cell1603 5.001504010 0.8748142 Mutant 1.0973774031
+#> Cell1832 5.534667547 0.8780645 Mutant 1.2156946960
+#> Cell1298 1.949619488 0.8562094 Mutant 0.4201166936
+#> Cell1116 2.366846100 0.8587529 Mutant 0.5127057773
+#> Cell68 -7.757721249 0.7970318 WT -1.7340934105
+#> Cell1728 6.403440311 0.8833607 Mutant 1.4084889037
+#> Cell1695 6.045113983 0.8811763 Mutant 1.3289707106
+#> Cell1183 3.660341044 0.8666383 Mutant 0.7997524519
+#> Cell1623 4.864560139 0.8739794 Mutant 1.0669874252
+#> Cell972 0.187652888 0.8454681 WT 0.0291088621
+#> Cell331 -7.465588627 0.7988126 WT -1.6692646316
+#> Cell1109 8.857410626 0.8983205 Mutant 1.9530631379
+#> Cell243 -2.878180266 0.8267783 WT -0.6512472660
+#> Cell1951 2.112293398 0.8572011 Mutant 0.4562165680
+#> Cell1393 5.596570440 0.8784419 Mutant 1.2294319123
+#> Cell311 -2.019316321 0.8320141 WT -0.4606519796
+#> Cell604 -1.655241218 0.8342335 WT -0.3798580438
+#> Cell1734 2.247682808 0.8580264 Mutant 0.4862615868
+#> Cell1440 3.031404651 0.8628042 Mutant 0.6601816705
+#> Cell1558 5.255200961 0.8763608 Mutant 1.1536767080
+#> Cell1582 3.733589916 0.8670848 Mutant 0.8160075175
+#> Cell1588 3.693784729 0.8668421 Mutant 0.8071741265
+#> Cell381 0.812361309 0.8492765 WT 0.1677413906
+#> Cell566 -4.678835899 0.8158012 WT -1.0508407967
+#> Cell1172 2.695875385 0.8607587 Mutant 0.5857225003
+#> Cell938 -3.253830408 0.8244883 WT -0.7346098834
+#> Cell1163 4.807844183 0.8736336 Mutant 1.0544012713
+#> Cell939 -2.964059105 0.8262548 WT -0.6703051180
+#> Cell1217 0.459142721 0.8471232 Mutant 0.0893566846
+#> Cell25 -2.278223762 0.8304357 WT -0.5181075733
+#> Cell1045 -1.481385467 0.8352934 Mutant -0.3412767446
+#> Cell1170 5.846668464 0.8799665 Mutant 1.2849325592
+#> Cell72 -2.631285678 0.8282834 WT -0.5964575115
+#> Cell1729 1.053435876 0.8507461 Mutant 0.2212395918
+#> Cell474 -7.600605343 0.7979896 WT -1.6992269437
+#> Cell1453 6.930854651 0.8865759 Mutant 1.5255303605
+#> Cell762 -8.678230809 0.7914202 WT -1.9383688190
+#> Cell1512 4.714015627 0.8730616 Mutant 1.0335792531
+#> Cell1536 2.599281238 0.8601699 Mutant 0.5642867547
+#> Cell1921 5.258277967 0.8763796 Mutant 1.1543595435
+#> Cell1725 4.684972679 0.8728846 Mutant 1.0271341707
+#> Cell1757 4.887216244 0.8741175 Mutant 1.0720151677
+#> Cell184 -5.738339839 0.8093423 WT -1.2859612232
+#> Cell646 -5.856346761 0.8086229 WT -1.3121487972
+#> Cell1123 6.083251283 0.8814087 Mutant 1.3374339715
+#> Cell1250 1.929086990 0.8560842 Mutant 0.4155602127
+#> Cell391 -2.187684787 0.8309877 WT -0.4980155646
+#> Cell1821 0.509682132 0.8474313 Mutant 0.1005721671
+#> Cell1288 7.200560526 0.8882201 Mutant 1.5853822949
+#> Cell1260 2.323416464 0.8584881 Mutant 0.5030680648
+#> Cell1567 4.235475170 0.8701444 Mutant 0.9273836724
+#> Cell1513 2.163585874 0.8575138 Mutant 0.4675991673
+#> Cell1650 6.068290008 0.8813175 Mutant 1.3341138315
+#> Cell1626 3.863855419 0.8678789 Mutant 0.8449154617
+#> Cell364 -3.557349073 0.8226380 WT -0.8019654025
+#> Cell1761 2.378837740 0.8588260 Mutant 0.5153669090
+#> Cell289 -3.440122872 0.8233526 WT -0.7759510828
+#> Cell1196 1.443415506 0.8531235 Mutant 0.3077821457
+#> Cell924 0.819752900 0.8493215 WT 0.1693816999
+#> Cell1485 6.179335420 0.8819945 Mutant 1.3587565380
+#> Cell524 -1.781798056 0.8334620 WT -0.4079429771
+#> Cell1569 4.048763896 0.8690062 Mutant 0.8859495327
+#> Cell1605 3.501325834 0.8656689 Mutant 0.7644645002
+#> Cell722 -6.643534474 0.8038240 WT -1.4868380113
+#> Cell332 0.575468095 0.8478323 WT 0.1151710968
+#> Cell1390 5.618155426 0.8785734 Mutant 1.2342219569
+#> Cell408 -5.784621645 0.8090601 WT -1.2962318768
+#> Cell1367 5.942578847 0.8805512 Mutant 1.3062165669
+#> Cell841 -4.193895017 0.8187575 WT -0.9432248619
+#> Cell1285 2.182493505 0.8576290 Mutant 0.4717950652
+#> Cell1385 4.675322405 0.8728258 Mutant 1.0249926247
+#> Cell1379 2.306977356 0.8583879 Mutant 0.4994199705
+#> Cell656 -0.256014899 0.8427635 WT -0.0693479301
+#> Cell672 -5.776461193 0.8091099 WT -1.2944209454
+#> Cell517 -2.511700193 0.8290124 WT -0.5699196299
+#> Cell109 -2.055887381 0.8317911 WT -0.4687676674
+#> Cell875 -5.022786907 0.8137044 WT -1.1271688825
+#> Cell1638 3.724671257 0.8670304 Mutant 0.8140283282
+#> Cell26 -1.347845310 0.8361075 WT -0.3116421039
+#> Cell390 -5.048260481 0.8135491 WT -1.1328218654
+#> Cell798 -5.282588541 0.8121206 WT -1.1848229115
+#> Cell1422 1.957907393 0.8562599 Mutant 0.4219559089
+#> Cell541 -1.570781983 0.8347484 WT -0.3611152240
+#> Cell1308 1.752834071 0.8550098 Mutant 0.3764469447
+#> Cell457 -4.922316496 0.8143169 WT -1.1048729336
+#> Cell958 -5.000886103 0.8138379 WT -1.1223087529
+#> Cell620 -13.801596599 0.7601872 WT -3.0753234856
+#> Cell192 -6.907141691 0.8022170 WT -1.5453365586
+#> Cell1976 4.420621073 0.8712731 Mutant 0.9684704321
+#> Cell1901 2.630159582 0.8603581 Mutant 0.5711391402
+#> Cell598 -3.115142716 0.8253337 WT -0.7038329244
+#> Cell1544 3.996915000 0.8686901 Mutant 0.8744434549
+#> Cell1286 6.978705101 0.8868676 Mutant 1.5361491206
+#> Cell442 0.811831819 0.8492733 WT 0.1676238886
+#> Cell547 0.077313218 0.8447955 WT 0.0046227707
+#> Cell905 -1.965606373 0.8323415 WT -0.4487329057
+#> Cell618 -6.033430226 0.8075433 WT -1.3514463760
+#> Cell175 -2.311414024 0.8302334 WT -0.5254730095
+#> Cell1266 1.707764027 0.8547350 Mutant 0.3664451999
+#> Cell199 -1.413353958 0.8357081 WT -0.3261794932
+#> Cell1961 4.397946985 0.8711348 Mutant 0.9634386986
+#> Cell1965 2.819974751 0.8615152 Mutant 0.6132620825
+#> Cell226 -4.693816739 0.8157099 WT -1.0541652784
+#> Cell970 -12.202279212 0.7699370 WT -2.7204100476
+#> Cell944 0.834301696 0.8494102 WT 0.1726103042
+#> Cell1597 3.834620171 0.8677007 Mutant 0.8384277046
+#> Cell1824 3.844375953 0.8677602 Mutant 0.8405926647
+#> Cell1493 14.096638401 0.9302598 Mutant 3.1157293838
+#> Cell1218 3.214863249 0.8639226 Mutant 0.7008939909
+#> Cell1337 2.883115931 0.8619002 Mutant 0.6272740939
+#> Cell1852 1.458071253 0.8532128 Mutant 0.3110344844
+#> Cell720 -3.251843285 0.8245004 WT -0.7341689098
+#> Cell1413 4.485220975 0.8716669 Mutant 0.9828061563
+#> Cell268 -11.526484033 0.7740567 WT -2.5704405717
+#> Cell639 -4.620982153 0.8161539 WT -1.0380021495
+#> Cell297 -4.806658438 0.8150220 WT -1.0792066089
+#> Cell1418 5.178101268 0.8758908 Mutant 1.1365670852
+#> Cell1714 7.859776280 0.8922388 Mutant 1.7316725382
+#> Cell1887 3.564310784 0.8660528 Mutant 0.7784418415
+#> Cell856 -5.914378561 0.8082691 WT -1.3250269573
+#> Cell1237 3.100347535 0.8632244 Mutant 0.6754811703
+#> Cell755 -4.475971984 0.8170379 WT -1.0058221343
+#> Cell1205 4.906683334 0.8742362 Mutant 1.0763352182
+#> Cell1136 2.629879377 0.8603564 Mutant 0.5710769584
+#> Cell362 1.725328474 0.8548421 WT 0.3703430243
+#> Cell320 -0.930279935 0.8386530 WT -0.2189778436
+#> Cell835 -6.185537553 0.8066161 WT -1.3852013610
+#> Cell1817 2.473187320 0.8594012 Mutant 0.5363045504
+#> Cell1827 1.750728100 0.8549969 Mutant 0.3759795970
+#> Cell650 -6.759905272 0.8031146 WT -1.5126625038
+#> Cell1209 3.433912618 0.8652579 Mutant 0.7495044576
+#> Cell804 1.329238900 0.8524275 WT 0.2824445787
+#> Cell1321 5.487961564 0.8777798 Mutant 1.2053299110
+#> Cell816 -2.035782346 0.8319137 WT -0.4643060471
+#> Cell93 -1.680101026 0.8340820 WT -0.3853748222
+#> Cell396 -3.655224536 0.8220413 WT -0.8236854923
+#> Cell1762 2.058807337 0.8568750 Mutant 0.4443471780
+#> Cell1014 3.840937531 0.8677392 Mutant 0.8398296252
+#> Cell1781 0.788931529 0.8491336 Mutant 0.1625419576
+#> Cell1207 4.214877358 0.8700188 Mutant 0.9228126971
+#> Cell1158 1.812324292 0.8553724 Mutant 0.3896487514
+#> Cell887 -2.846890977 0.8269690 WT -0.6443036856
+#> Cell1450 3.102891602 0.8632400 Mutant 0.6760457384
+#> Cell898 -2.657024434 0.8281265 WT -0.6021693424
+#> Cell236 -2.320016634 0.8301810 WT -0.5273820626
+#> Cell1008 4.445477052 0.8714246 Mutant 0.9739863608
+#> Cell1795 3.638052494 0.8665024 Mutant 0.7948062755
+#> Cell1201 4.967158121 0.8746048 Mutant 1.0897555154
+#> Cell36 1.710862461 0.8547539 WT 0.3671327907
+#> Cell42 -7.133920224 0.8008346 WT -1.5956622470
+#> Cell1164 2.663221087 0.8605596 Mutant 0.5784760030
+#> Cell619 -1.084055693 0.8377156 WT -0.2531030793
+#> Cell279 -5.463196977 0.8110196 WT -1.2249027365
+#> Cell316 -3.112156062 0.8253519 WT -0.7031701394
+#> Cell451 -1.675321799 0.8341111 WT -0.3843142374
+#> Cell1063 0.077403733 0.8447960 Mutant 0.0046428574
+#> Cell1862 5.076201644 0.8752696 Mutant 1.1139539716
+#> Cell765 -4.497114731 0.8169090 WT -1.0105140392
+#> Cell1675 5.536262560 0.8780742 Mutant 1.2160486544
+#> Cell694 1.443714899 0.8531253 WT 0.3078485857
+#> Cell1085 5.519275754 0.8779707 Mutant 1.2122790176
+#> Cell860 -3.278277485 0.8243392 WT -0.7400350706
+#> Cell1732 7.582570032 0.8905489 Mutant 1.6701561542
+#> Cell1128 5.978390237 0.8807695 Mutant 1.3141636722
+#> Cell167 -4.038964895 0.8197019 WT -0.9088434548
+#> Cell974 -2.371104049 0.8298695 WT -0.5387191557
+#> Cell126 -1.729902781 0.8337784 WT -0.3964266073
+#> Cell317 -7.354865111 0.7994876 WT -1.6446933588
+#> Cell873 -1.445274384 0.8355135 WT -0.3332631328
+#> Cell1313 -1.398594485 0.8357981 Mutant -0.3229041363
+#> Cell1580 2.893457186 0.8619632 Mutant 0.6295689794
+#> Cell957 -4.127493295 0.8191623 WT -0.9284892857
+#> Cell568 -4.627982200 0.8161112 WT -1.0395555689
+#> Cell494 -1.026004705 0.8380695 WT -0.2402206609
+#> Cell1099 1.345222571 0.8525249 Mutant 0.2859916041
+#> Cell14 -0.496625249 0.8412967 WT -0.1227431145
+#> Cell1110 2.231036958 0.8579250 Mutant 0.4825676134
+#> Cell1169 4.488091070 0.8716844 Mutant 0.9834430752
+#> Cell1557 3.964399007 0.8684919 Mutant 0.8672276498
+#> Cell839 -7.451147539 0.7989007 WT -1.6660599292
+#> Cell577 -4.648033417 0.8159890 WT -1.0440052463
+#> Cell1267 0.497422597 0.8473566 Mutant 0.0978515853
+#> Cell375 -3.199803855 0.8248176 WT -0.7226205498
+#> Cell1469 5.711182483 0.8791405 Mutant 1.2548661096
+#> Cell673 -5.718998948 0.8094602 WT -1.2816691782
+#> Cell482 -1.688151293 0.8340329 WT -0.3871613020
+#> Cell139 -1.223009512 0.8368685 WT -0.2839390960
+#> Cell615 -4.386850676 0.8175812 WT -0.9860447280
+#> Cell617 -1.178983297 0.8371369 WT -0.2741689932
+#> Cell1678 1.040850617 0.8506694 Mutant 0.2184467268
+#> Cell1809 4.959103676 0.8745557 Mutant 1.0879681085
+#> Cell1606 3.894338306 0.8680647 Mutant 0.8516800890
+#> Cell1190 3.784759071 0.8673967 Mutant 0.8273627501
+#> Cell1047 0.747154077 0.8488790 Mutant 0.1532708902
+#> Cell1560 2.120105028 0.8572487 Mutant 0.4579500905
+#> Cell1033 10.793850256 0.9101254 Mutant 2.3827892525
+#> Cell583 -4.992521381 0.8138889 WT -1.1204524909
+#> Cell1320 4.232162975 0.8701242 Mutant 0.9266486448
+#> Cell1920 2.417014883 0.8590587 Mutant 0.5238390117
+#> Cell761 -6.027181391 0.8075814 WT -1.3500596622
+#> Cell288 -3.839365603 0.8209187 WT -0.8645492631
+#> Cell560 -2.784769655 0.8273477 WT -0.6305179967
+#> Cell1178 2.457754058 0.8593071 Mutant 0.5328796691
+#> Cell1300 1.603117135 0.8540971 Mutant 0.3432224248
+#> Cell504 -4.652896716 0.8159593 WT -1.0450844880
+#> Cell789 -1.475443025 0.8353296 WT -0.3399580243
+#> Cell1806 2.120350479 0.8572502 Mutant 0.4580045598
+#> Cell374 -1.988832941 0.8321999 WT -0.4538872429
+#> Cell1211 3.809431453 0.8675471 Mutant 0.8328379358
+#> Cell1669 0.952069157 0.8501282 Mutant 0.1987447382
+#> Cell784 1.270151186 0.8520672 WT 0.2693320947
+#> Cell1525 4.976566723 0.8746622 Mutant 1.0918434308
+#> Cell1443 3.178557493 0.8637012 Mutant 0.6928371780
+#> Cell575 -1.013407473 0.8381463 WT -0.2374251389
+#> Cell823 -4.865908431 0.8146608 WT -1.0923551053
+#> Cell1822 2.617659532 0.8602819 Mutant 0.5683651844
+#> Cell959 -1.348652497 0.8361026 WT -0.3118212312
+#> Cell521 -1.040847213 0.8379790 WT -0.2435144446
+#> Cell1324 3.896960969 0.8680807 Mutant 0.8522620987
+#> Cell880 -15.510186148 0.7497714 WT -3.4544861185
+#> Cell1784 4.624068630 0.8725133 Mutant 1.0136186136
+#> Cell1715 1.125425269 0.8511850 Mutant 0.2372151594
+#> Cell1383 5.131597576 0.8756073 Mutant 1.1262471915
+#> Cell1923 3.849343260 0.8677905 Mutant 0.8416949875
+#> Cell1295 4.433528547 0.8713517 Mutant 0.9713348014
+#> Cell1484 1.537295209 0.8536958 Mutant 0.3286155140
+#> Cell475 -5.108410771 0.8131824 WT -1.1461701516
+#> Cell1886 3.725249632 0.8670340 Mutant 0.8141566787
+#> Cell1881 2.162977985 0.8575101 Mutant 0.4674642673
+#> Cell169 -2.921309701 0.8265154 WT -0.6608183595
+#> Cell136 -3.074668000 0.8255805 WT -0.6948509546
+#> Cell76 -6.437923832 0.8050775 WT -1.4412098074
+#> Cell1823 4.315765974 0.8706338 Mutant 0.9452014524
+#> Cell334 -5.946781369 0.8080716 WT -1.3322176452
+#> Cell1100 1.667307923 0.8544884 Mutant 0.3574673604
+#> Cell849 -6.875966530 0.8024071 WT -1.5384183046
+#> Cell41 -5.962514186 0.8079757 WT -1.3357090023
+#> Cell1458 0.613450696 0.8480639 Mutant 0.1236000275
+#> Cell127 1.009587802 0.8504788 WT 0.2115090214
+#> Cell963 -3.722376974 0.8216319 WT -0.8385876641
+#> Cell996 -0.056950543 0.8439770 WT -0.0251724491
+#> Cell218 -4.935780384 0.8142348 WT -1.1078607799
+#> Cell911 -4.425448208 0.8173459 WT -0.9946101214
+#> Cell764 -2.943014520 0.8263831 WT -0.6656349969
+#> Cell1093 3.998314337 0.8686986 Mutant 0.8747539896
+#> Cell1305 3.799995113 0.8674896 Mutant 0.8307438651
+#> Cell661 -2.563705039 0.8286954 WT -0.5814603151
+#> Cell462 -6.449408812 0.8050075 WT -1.4437585033
+#> Cell1932 7.419869375 0.8895570 Mutant 1.6340503443
+#> Cell1660 2.148319967 0.8574207 Mutant 0.4642114247
+#> Cell1052 2.397818122 0.8589417 Mutant 0.5195789514
+#> Cell1072 15.747224286 0.9403220 Mutant 3.4820201001
+#> Cell1601 2.797245540 0.8613767 Mutant 0.6082181167
+#> Cell806 -2.508081312 0.8290345 WT -0.5691165437
+#> Cell188 -0.300440558 0.8424926 WT -0.0792066759
+#> Cell601 -3.824720192 0.8210080 WT -0.8612992184
+#> Cell1672 2.969972318 0.8624297 Mutant 0.6465488790
+#> Cell1332 3.549073549 0.8659600 Mutant 0.7750604618
+#> Cell421 -5.784453031 0.8090611 WT -1.2961944586
+#> Cell1803 4.827867243 0.8737557 Mutant 1.0588447001
+#> Cell177 -5.459927684 0.8110395 WT -1.2241772296
+#> Cell1386 1.636956594 0.8543034 Mutant 0.3507319277
+#> Cell1530 1.902498670 0.8559221 Mutant 0.4096598502
+#> Cell24 -4.355617872 0.8177716 WT -0.9791136823
+#> Cell1819 3.406465395 0.8650906 Mutant 0.7434134913
+#> Cell1999 4.324124222 0.8706848 Mutant 0.9470562779
+#> Cell1617 1.782221069 0.8551889 Mutant 0.3829683772
+#> Cell1753 4.307346274 0.8705825 Mutant 0.9433329897
+#> Cell1212 3.329496904 0.8646214 Mutant 0.7263329844
+#> Cell1073 3.191202763 0.8637783 Mutant 0.6956433604
+#> Cell1831 4.375984709 0.8710010 Mutant 0.9585649277
+#> Cell1309 1.008636574 0.8504730 Mutant 0.2112979289
+#> Cell1432 3.135758455 0.8634403 Mutant 0.6833394050
+#> Cell553 -3.467408858 0.8231863 WT -0.7820062680
+#> Cell1319 -0.162075334 0.8433361 Mutant -0.0485012776
+#> Cell1866 2.761910198 0.8611613 Mutant 0.6003766539
+#> Cell986 -1.910366233 0.8326783 WT -0.4364742583
+#> Cell928 -2.648884290 0.8281761 WT -0.6003629177
+#> Cell950 -3.879478211 0.8206742 WT -0.8734508756
+#> Cell1933 2.140840025 0.8573751 Mutant 0.4625515092
+#> Cell1229 3.527792694 0.8658302 Mutant 0.7703379087
+#> Cell58 -1.972284790 0.8323008 WT -0.4502149504
+#> Cell15 0.790491100 0.8491432 WT 0.1628880506
+#> Cell812 -4.116034286 0.8192321 WT -0.9259463530
+#> Cell948 -2.735137070 0.8276503 WT -0.6195037530
+#> Cell667 -5.035387417 0.8136276 WT -1.1299651320
+#> Cell87 0.144387676 0.8452044 WT 0.0195076376
+#> Cell1176 4.157537450 0.8696693 Mutant 0.9100880784
+#> Cell855 -2.597147769 0.8284915 WT -0.5888817779
+#> Cell1548 2.498212906 0.8595537 Mutant 0.5418581176
+#> Cell886 -2.352135770 0.8299852 WT -0.5345097991
+#> Cell1882 2.492004873 0.8595159 Mutant 0.5404804583
+#> Cell1079 2.395341874 0.8589266 Mutant 0.5190294334
+#> Cell842 -5.304537908 0.8119868 WT -1.1896938181
+#> Cell1553 6.111333870 0.8815799 Mutant 1.3436659350
+#> Cell1411 6.102750848 0.8815276 Mutant 1.3417612287
+#> Cell272 -5.144374935 0.8129632 WT -1.1541511597
+#> Cell437 -1.963355810 0.8323552 WT -0.4482334707
+#> Cell1480 2.820251338 0.8615169 Mutant 0.6133234615
+#> Cell1449 2.973986699 0.8624541 Mutant 0.6474397326
+#> Cell760 -1.197136099 0.8370262 WT -0.2781973826
+#> Cell222 -2.560759207 0.8287133 WT -0.5808065892
+#> Cell858 -0.214524061 0.8430164 WT -0.0601404670
+#> Cell684 -4.317017162 0.8180069 WT -0.9705475836
+#> Cell913 -4.612035395 0.8162084 WT -1.0360167244
+#> Cell654 0.237775381 0.8457737 WT 0.0402318239
+#> Cell1643 5.427486383 0.8774111 Mutant 1.1919095264
+#> Cell505 0.665707959 0.8483825 WT 0.1351967281
+#> Cell1025 2.697772608 0.8607703 Mutant 0.5861435237
+#> Cell434 -9.784708677 0.7846749 WT -2.1839134916
+#> Cell750 -3.388674265 0.8236662 WT -0.7645338356
+#> Cell1969 2.163835692 0.8575153 Mutant 0.4676546059
+#> Cell713 0.816841445 0.8493038 WT 0.1687356026
+#> Cell1130 3.194021228 0.8637955 Mutant 0.6962688218
+#> Cell1392 5.742891403 0.8793339 Mutant 1.2619028129
+#> Cell113 -4.088663388 0.8193990 WT -0.9198723244
+#> Cell961 -2.209399972 0.8308553 WT -0.5028345024
+#> Cell810 -5.558811033 0.8104367 WT -1.2461209848
+#> Cell1849 5.286355061 0.8765507 Mutant 1.1605902879
+#> Cell1518 3.334957360 0.8646547 Mutant 0.7275447446
+#> Cell1358 7.441886976 0.8896912 Mutant 1.6389363928
+#> Cell152 -2.332458003 0.8301051 WT -0.5301429961
+#> Cell359 -1.650923338 0.8342599 WT -0.3788998390
+#> Cell440 -0.362972388 0.8421114 WT -0.0930834628
+#> Cell1624 3.008374230 0.8626638 Mutant 0.6550708613
+#> Cell1875 5.073292155 0.8752519 Mutant 1.1133083106
+#> Cell1501 0.629858212 0.8481639 Mutant 0.1272411108
+#> Cell506 1.828282208 0.8554697 WT 0.3931900614
+#> Cell260 -2.855632936 0.8269157 WT -0.6462436623
+#> Cell878 -1.618420692 0.8344580 WT -0.3716869956
+#> Cell1919 3.676085523 0.8667342 Mutant 0.8032463971
+#> Cell278 -4.518570696 0.8167782 WT -1.0152754521
+#> Cell256 -5.303474373 0.8119933 WT -1.1894578031
+#> Cell217 -3.335876716 0.8239881 WT -0.7528172370
+#> Cell1070 2.428662870 0.8591297 Mutant 0.5264238814
+#> Cell1135 2.600026552 0.8601744 Mutant 0.5644521515
+#> Cell1878 6.958891308 0.8867468 Mutant 1.5317521314
+#> Cell1426 4.946295709 0.8744777 Mutant 1.0851258212
+#> Cell73 -1.517182046 0.8350752 WT -0.3492205632
+#> Cell1883 3.057634440 0.8629641 Mutant 0.6660024693
+#> Cell830 -5.134258693 0.8130248 WT -1.1519062081
+#> Cell98 0.014714916 0.8444139 WT -0.0092687676
+#> Cell1372 4.379911848 0.8710249 Mutant 0.9594364209
+#> Cell1744 6.303191279 0.8827495 Mutant 1.3862420822
+#> Cell557 -4.548873392 0.8165935 WT -1.0220000922
+#> Cell1532 6.069628736 0.8813257 Mutant 1.3344109160
+#> Cell1815 3.054876067 0.8629472 Mutant 0.6653903432
+#> Cell465 -1.420364837 0.8356654 WT -0.3277353164
+#> Cell1112 3.980903399 0.8685925 Mutant 0.8708902314
+#> Cell578 2.813923248 0.8614784 WT 0.6119191598
+#> Cell1451 5.470021379 0.8776704 Mutant 1.2013487045
+#> Cell677 -1.701957714 0.8339487 WT -0.3902251617
+#> Cell275 -9.659974714 0.7854353 WT -2.1562330825
+#> Cell1607 -2.116325795 0.8314227 Mutant -0.4821798928
+#> Cell65 -5.238278391 0.8123907 WT -1.1749897992
+#> Cell265 -14.088440045 0.7584386 WT -3.1389785140
+#> Cell528 0.550461288 0.8476799 WT 0.1096216968
+#> Cell609 -5.921293409 0.8082269 WT -1.3265614699
+#> Cell1507 3.327981014 0.8646121 Mutant 0.7259965848
+#> Cell624 -8.942327993 0.7898102 WT -1.9969760975
+#> Cell458 -3.216937946 0.8247132 WT -0.7264228716
+#> Cell1681 5.007296675 0.8748495 Mutant 1.0986628858
+#> Cell1993 3.835135042 0.8677038 Mutant 0.8385419626
+#> Cell803 -5.202823848 0.8126069 WT -1.1671218840
+#> Cell665 -1.995467644 0.8321595 WT -0.4553595868
+#> Cell1830 -2.443915095 0.8294256 Mutant -0.5548770608
+#> Cell532 -4.282955264 0.8182145 WT -0.9629887179
+#> Cell644 -2.377470676 0.8298307 WT -0.5401320093
+#> Cell1490 2.941128296 0.8622538 Mutant 0.6401479413
+#> Cell990 -0.189122168 0.8431713 WT -0.0545033913
+#> Cell1448 5.351288790 0.8769466 Mutant 1.1750000937
+#> Cell1931 4.178638112 0.8697979 Mutant 0.9147706441
+#> Cell1665 3.382918223 0.8649470 Mutant 0.7381880071
+#> Cell1736 3.700279139 0.8668817 Mutant 0.8086153372
+#> Cell208 -4.474562235 0.8170465 WT -1.0055092891
+#> Cell758 -4.774790460 0.8152162 WT -1.0721346084
+#> Cell227 -2.399824132 0.8296944 WT -0.5450925893
+#> Cell781 -5.581493741 0.8102984 WT -1.2511546311
+#> Cell1456 2.282546644 0.8582390 Mutant 0.4939984150
+#> Cell1111 4.923235536 0.8743371 Mutant 1.0800084096
+#> Cell1454 0.802827364 0.8492184 Mutant 0.1656256599
+#> Cell57 -2.356628169 0.8299578 WT -0.5355067324
+#> Cell1925 0.765863398 0.8489930 Mutant 0.1574227801
+#> Cell180 -3.723327590 0.8216261 WT -0.8387986208
+#> Cell1213 2.961676237 0.8623791 Mutant 0.6447078493
+#> Cell360 -7.501587108 0.7985932 WT -1.6772532551
+#> Cell1388 0.625634345 0.8481382 Mutant 0.1263037691
+#> Cell968 -2.321066475 0.8301746 WT -0.5276150386
+#> Cell149 -5.999438736 0.8077506 WT -1.3439031351
+#> Cell449 -0.757431426 0.8397067 WT -0.1806200672
+#> Cell1654 4.096880894 0.8692995 Mutant 0.8966274439
+#> Cell1596 5.547733595 0.8781441 Mutant 1.2185942556
+#> Cell407 -3.318486856 0.8240941 WT -0.7489581563
+#> Cell1546 0.687352108 0.8485144 Mutant 0.1399999018
+#> Cell1228 2.017229935 0.8566216 Mutant 0.4351205050
+#> Cell1333 4.421323140 0.8712773 Mutant 0.9686262315
+#> Cell1397 3.394335072 0.8650166 Mutant 0.7407215836
+#> Cell931 -2.394115707 0.8297292 WT -0.5438258010
+#> Cell492 -1.099543252 0.8376212 WT -0.2565400098
+#> Cell1756 4.106705793 0.8693594 Mutant 0.8988077420
+#> Cell710 -3.247728361 0.8245255 WT -0.7332557441
+#> Cell135 -5.059854560 0.8134784 WT -1.1353947721
+#> Cell1579 3.487951555 0.8655873 Mutant 0.7614965393
+#> Cell1255 2.319424067 0.8584638 Mutant 0.5021820897
+#> Cell1908 1.557930541 0.8538216 Mutant 0.3331948157
+#> Cell1786 2.360793074 0.8587160 Mutant 0.5113625165
+#> Cell481 -5.465691452 0.8110044 WT -1.2254562994
+#> Cell173 -7.446718328 0.7989277 WT -1.6650770183
+#> Cell74 -2.644633934 0.8282020 WT -0.5994196975
+#> Cell1783 3.091339058 0.8631695 Mutant 0.6734820489
+#> Cell1441 4.315746868 0.8706337 Mutant 0.9451972124
+#> Cell1287 3.720360688 0.8670042 Mutant 0.8130717459
+#> Cell1566 1.259519558 0.8520024 Mutant 0.2669727707
+#> Cell122 -6.903038346 0.8022421 WT -1.5444259623
+#> Cell1077 3.144717975 0.8634949 Mutant 0.6853276620
+#> Cell469 -7.046616636 0.8013668 WT -1.5762882212
+#> Cell638 -1.436607733 0.8355664 WT -0.3313398682
+#> Cell1977 2.884556426 0.8619089 Mutant 0.6275937622
+#> Cell1686 4.337423462 0.8707659 Mutant 0.9500075864
+#> Cell851 -3.752315907 0.8214494 WT -0.8452315798
+#> Cell242 -5.079950245 0.8133559 WT -1.1398543177
+#> Cell1902 3.403932649 0.8650752 Mutant 0.7428514356
+#> Cell1810 3.412701104 0.8651286 Mutant 0.7447972923
+#> Cell773 2.349337186 0.8586462 WT 0.5088202766
+#> Cell738 -3.995292851 0.8199682 WT -0.8991519480
+#> Cell1137 3.098294021 0.8632119 Mutant 0.6750254635
+#> Cell876 -0.048438604 0.8440289 WT -0.0232835173
+#> Cell495 -3.997716888 0.8199534 WT -0.8996898796
+#> Cell579 -3.504593100 0.8229596 WT -0.7902580306
+#> Cell1155 4.998723260 0.8747973 Mutant 1.0967603114
+#> Cell349 -2.462343655 0.8293133 WT -0.5589666454
+#> Cell1275 2.687362053 0.8607068 Mutant 0.5838332594
+#> Cell529 0.198503356 0.8455343 WT 0.0315167499
+#> Cell989 0.630634701 0.8481686 WT 0.1274134260
+#> Cell1068 4.821784766 0.8737186 Mutant 1.0574949037
+#> Cell1231 3.786000660 0.8674043 Mutant 0.8276382778
+#> Cell1542 1.892750173 0.8558627 Mutant 0.4074965071
+#> Cell1766 5.619921230 0.8785842 Mutant 1.2346138161
+#> Cell662 -6.814473680 0.8027820 WT -1.5247720835
+#> Cell1939 2.997972391 0.8626003 Mutant 0.6527625312
+#> Cell991 -5.035866359 0.8136247 WT -1.1300714168
+#> Cell900 -5.003188574 0.8138239 WT -1.1228197073
+#> Cell350 -5.856891405 0.8086195 WT -1.3122696621
+#> Cell1105 4.871124094 0.8740194 Mutant 1.0684440690
+#> Cell1161 3.460193650 0.8654181 Mutant 0.7553366278
+#> Cell307 -3.730341555 0.8215834 WT -0.8403551288
+#> Cell1680 3.586560418 0.8661885 Mutant 0.7833793819
+#> Cell915 -1.184810678 0.8371014 WT -0.2754621798
+#> Cell1537 3.854533637 0.8678221 Mutant 0.8428468129
+#> Cell536 -2.115077973 0.8314303 WT -0.4819029817
+#> Cell1464 5.416358653 0.8773433 Mutant 1.1894401099
+#> Cell1718 3.321093218 0.8645701 Mutant 0.7244680755
+#> Cell1222 1.350105892 0.8525547 Mutant 0.2870752892
+#> Cell1346 0.242337028 0.8458015 Mutant 0.0412441245
+#> Cell13 -1.336615416 0.8361759 WT -0.3091500155
+#> Cell1264 2.241701508 0.8579900 Mutant 0.4849342431
+#> Cell599 -3.898274872 0.8205596 WT -0.8776221475
+#> Cell1578 5.409611130 0.8773021 Mutant 1.1879427295
+#> Cell703 -3.201709335 0.8248060 WT -0.7230434056
+#> Cell605 -0.735202723 0.8398423 WT -0.1756871718
+#> Cell480 -5.120714897 0.8131074 WT -1.1489006289
+#> Cell1829 4.823959523 0.8737319 Mutant 1.0579775161
+#> Cell1056 4.792764816 0.8735417 Mutant 1.0510549248
+#> Cell1956 8.552491378 0.8964617 Mutant 1.8853968076
+#> Cell259 -7.553028226 0.7982796 WT -1.6886688405
+#> Cell1694 6.047569007 0.8811912 Mutant 1.3295155186
+#> Cell1074 2.347111270 0.8586326 Mutant 0.5083263111
+#> Cell16 -5.797644550 0.8089807 WT -1.2991218623
+#> Cell1444 1.768306627 0.8551041 Mutant 0.3798805458
+#> Cell893 0.201007909 0.8455496 WT 0.0320725492
+#> Cell1918 2.543403845 0.8598292 Mutant 0.5518866909
+#> Cell686 -3.143237296 0.8251625 WT -0.7100675493
+#> Cell1519 4.697006239 0.8729580 Mutant 1.0298046050
+#> Cell1619 2.476559186 0.8594217 Mutant 0.5370528198
+#> Cell1348 0.766450976 0.8489966 Mutant 0.1575531728
+#> Cell745 -0.659301316 0.8403050 WT -0.1588434675
+#> Cell1408 4.944346544 0.8744658 Mutant 1.0846932710
+#> Cell1790 10.742260242 0.9098109 Mutant 2.3713406248
+#> Cell183 1.387706707 0.8527839 WT 0.2954194957
+#> Cell725 -2.634714944 0.8282625 WT -0.5972185192
+#> Cell1027 2.877252483 0.8618644 Mutant 0.6259729034
+#> Cell516 -5.894440669 0.8083906 WT -1.3206024285
+#> Cell811 -4.506181354 0.8168537 WT -1.0125260641
+#> Cell1905 4.992353197 0.8747584 Mutant 1.0953466951
+#> Cell1461 2.964834268 0.8623983 Mutant 0.6454086656
+#> Cell1568 3.973536437 0.8685476 Mutant 0.8692553877
+#> Cell1278 4.410277935 0.8712100 Mutant 0.9661751286
+#> Cell927 -0.134722958 0.8435029 WT -0.0424313593
+#> Cell752 -1.746462316 0.8336774 WT -0.4001014261
+#> Cell39 -3.285300100 0.8242964 WT -0.7415934982
+#> Cell1641 3.354311456 0.8647727 Mutant 0.7318397199
+#> Cell1769 5.885843395 0.8802053 Mutant 1.2936260866
+#> Cell1271 4.817588253 0.8736930 Mutant 1.0565636320
+#> Cell430 -1.864688830 0.8329567 WT -0.4263377310
+#> Cell847 1.229967903 0.8518223 WT 0.2604147982
+#> Cell1735 0.801656837 0.8492112 Mutant 0.1653659015
+#> Cell1114 4.140353427 0.8695645 Mutant 0.9062746761
+#> Cell251 -2.154466216 0.8311902 WT -0.4906438463
+#> Cell693 -5.025854016 0.8136857 WT -1.1278495219
+#> Cell1147 2.686011869 0.8606986 Mutant 0.5835336326
+#> Cell527 -6.433225310 0.8051061 WT -1.4401671321
+#> Cell37 -0.880086984 0.8389590 WT -0.2078392459
+#> Cell460 -2.546460426 0.8288005 WT -0.5776334669
+#> Cell1013 3.611430796 0.8663401 Mutant 0.7888985062
+#> Cell29 -5.015415459 0.8137493 WT -1.1255330434
+#> Cell822 -2.336409877 0.8300810 WT -0.5310199786
+#> Cell1910 6.028404488 0.8810744 Mutant 1.3252626133
+#> Cell1258 2.951003706 0.8623140 Mutant 0.6423394485
+#> Cell33 -1.984246246 0.8322279 WT -0.4528693838
+#> Cell1253 1.467654177 0.8532713 Mutant 0.3131610844
+#> Cell917 -4.719723080 0.8155519 WT -1.0599142990
+#> Cell1394 4.368808833 0.8709572 Mutant 0.9569724890
+#> Cell1476 4.472466790 0.8715891 Mutant 0.9799758042
+#> Cell815 -5.942406242 0.8080982 WT -1.3312467363
+#> Cell203 0.274357520 0.8459967 WT 0.0483499704
+#> Cell861 -7.638790863 0.7977568 WT -1.7077009053
+#> Cell220 -5.370176126 0.8115866 WT -1.2042599609
+#> Cell1589 5.551010699 0.8781641 Mutant 1.2193214962
+#> Cell1235 4.870658083 0.8740166 Mutant 1.0683406538
+#> Cell1000 -5.348555111 0.8117185 WT -1.1994619209
+#> Cell416 -4.414480813 0.8174127 WT -0.9921762859
+#> Cell1126 1.558195656 0.8538232 Mutant 0.3332536489
+#> Cell1018 1.948846647 0.8562047 Mutant 0.4199451882
+#> Cell1006 4.861111497 0.8739584 Mutant 1.0662221178
+#> Cell1395 3.115589296 0.8633174 Mutant 0.6788635544
+#> Cell1587 0.942958517 0.8500726 Mutant 0.1967229451
+#> Cell1888 1.645193420 0.8543536 Mutant 0.3525598077
+#> Cell47 -0.267747737 0.8426919 WT -0.0719516296
+#> Cell1430 3.143583939 0.8634880 Mutant 0.6850760017
+#> Cell954 -5.597396192 0.8102015 WT -1.2546836326
+#> Cell20 -3.688963215 0.8218356 WT -0.8311726306
+#> Cell1755 1.372905540 0.8526937 Mutant 0.2921348861
+#> Cell106 -4.433565838 0.8172964 WT -0.9964115500
+#> Cell499 -1.612528820 0.8344939 WT -0.3703794973
+#> Cell1246 2.448497074 0.8592506 Mutant 0.5308254001
+#> Cell6 -3.214696805 0.8247268 WT -0.7259255273
+#> Cell32 -2.615157036 0.8283817 WT -0.5928783148
+#> Cell770 -2.023106052 0.8319910 WT -0.4614929799
+#> Cell445 -1.237742433 0.8367787 WT -0.2872085607
+#> Cell1851 3.474343355 0.8655044 Mutant 0.7584766677
+#> Cell1805 4.640861512 0.8726157 Mutant 1.0173452158
+#> Cell1059 3.939934653 0.8683427 Mutant 0.8617986286
+#> Cell1676 2.616644027 0.8602757 Mutant 0.5681398279
+#> Cell739 -1.945994993 0.8324611 WT -0.4443808349
+#> Cell301 -7.280541041 0.7999407 WT -1.6281996900
+#> Cell95 -7.269255962 0.8000095 WT -1.6256953552
+#> Cell1414 2.015880972 0.8566133 Mutant 0.4348211490
+#> Cell328 -4.637247151 0.8160547 WT -1.0416116058
+#> Cell498 -0.370219347 0.8420673 WT -0.0946916760
+#> Cell171 -2.998080814 0.8260474 WT -0.6778550652
+#> Cell132 -2.533510193 0.8288795 WT -0.5747596084
+#> Cell1573 2.917303755 0.8621086 Mutant 0.6348609045
+#> Cell263 -4.529245082 0.8167131 WT -1.0176442646
+#> Cell623 -4.829405385 0.8148833 WT -1.0842545109
+#> Cell1482 2.369018940 0.8587661 Mutant 0.5131879643
+#> Cell255 -6.715196623 0.8033872 WT -1.5027409584
+#> Cell395 -4.903639814 0.8144307 WT -1.1007282870
+#> Cell1730 2.712155676 0.8608580 Mutant 0.5893353506
+#> Cell483 -4.774796983 0.8152162 WT -1.0721360558
+#> Cell1034 6.959922286 0.8867531 Mutant 1.5319809216
+#> Cell587 -4.069732113 0.8195144 WT -0.9156711796
+#> Cell1322 2.270152463 0.8581634 Mutant 0.4912479533
+#> Cell63 -3.237842942 0.8245857 WT -0.7310620156
+#> Cell882 -1.881731178 0.8328528 WT -0.4301196934
+#> Cell1427 4.329921631 0.8707201 Mutant 0.9483428130
+#> Cell1627 5.130336580 0.8755996 Mutant 1.1259673570
+#> Cell1948 3.381770705 0.8649400 Mutant 0.7379333549
+#> Cell1011 6.063291409 0.8812871 Mutant 1.3330045646
+#> Cell607 -1.614551319 0.8344816 WT -0.3708283213
+#> Cell376 -5.534697730 0.8105837 WT -1.2407698673
+#> Cell224 -2.657125666 0.8281259 WT -0.6021918074
+#> Cell658 -3.870323272 0.8207300 WT -0.8714192521
+#> Cell1447 3.794372237 0.8674553 Mutant 0.8294960612
+#> Cell1659 4.608717809 0.8724197 Mutant 1.0102120273
+#> Cell1223 3.585599715 0.8661826 Mutant 0.7831661870
+#> Cell688 -2.407077844 0.8296502 WT -0.5467023010
+#> Cell103 -2.346748340 0.8300180 WT -0.5333142445
+#> Cell867 -4.026942764 0.8197752 WT -0.9061755567
+#> Cell1371 3.616564881 0.8663714 Mutant 0.7900378396
+#> Cell1802 5.245142860 0.8762995 Mutant 1.1514446586
+#> Cell685 -6.945613827 0.8019825 WT -1.5538741247
+#> Cell1724 4.570304919 0.8721856 Mutant 1.0016876088
+#> Cell879 -8.904717776 0.7900395 WT -1.9886298045
+#> Cell647 -3.360193202 0.8238399 WT -0.7582134440
+#> Cell641 2.290561777 0.8582878 WT 0.4957770978
+#> Cell1938 6.172341765 0.8819519 Mutant 1.3572045370
+#> Cell1745 3.718833652 0.8669948 Mutant 0.8127328727
+#> Cell1586 2.698654587 0.8607757 Mutant 0.5863392485
+#> Cell326 -18.265870340 0.7329722 WT -4.0660153612
+#> Cell1621 1.333476956 0.8524533 Mutant 0.2833850694
+#> Cell1716 3.509726423 0.8657201 Mutant 0.7663287216
+#> Cell1794 1.395343215 0.8528304 Mutant 0.2971141556
+#> Cell872 -3.837570886 0.8209297 WT -0.8641509873
+#> Cell843 0.093709509 0.8448955 WT 0.0082613630
+#> Cell1165 1.030655316 0.8506072 Mutant 0.2161842308
+#> Cell1343 6.124400510 0.8816596 Mutant 1.3465656258
+#> Cell1572 4.304010610 0.8705622 Mutant 0.9425927539
+#> Cell1870 3.617627058 0.8663779 Mutant 0.7902735531
+#> Cell1329 3.096530794 0.8632012 Mutant 0.6746341759
+#> Cell1142 2.224180990 0.8578832 Mutant 0.4810461673
+#> Cell1917 4.764195933 0.8733676 Mutant 1.0447150448
+#> Cell1926 5.464900342 0.8776392 Mutant 1.2002122667
+#> Cell379 -3.685802622 0.8218549 WT -0.8304712458
+#> Cell1081 3.877698917 0.8679633 Mutant 0.8479875494
+#> Cell1020 2.450118402 0.8592605 Mutant 0.5311851982
+#> Cell1387 1.290023873 0.8521884 Mutant 0.2737421534
+#> Cell302 -1.948362100 0.8324466 WT -0.4449061330
+#> Cell1658 4.537313460 0.8719844 Mutant 0.9943662903
+#> Cell754 -3.049089327 0.8257364 WT -0.6891746485
+#> Cell696 -2.936196494 0.8264246 WT -0.6641219708
+#> Cell1531 5.842394476 0.8799404 Mutant 1.2839840947
+#> Cell1740 3.259529110 0.8641948 Mutant 0.7108060410
+#> Cell1692 6.580177340 0.8844381 Mutant 1.4477096033
+#> Cell1240 3.497488321 0.8656455 Mutant 0.7636128963
+#> Cell1043 2.196907383 0.8577169 Mutant 0.4749937292
+#> Cell1435 3.261256493 0.8642054 Mutant 0.7111893742
+#> Cell744 2.281988300 0.8582356 WT 0.4938745099
+#> Cell1591 8.518784386 0.8962562 Mutant 1.8779167013
+#> Cell114 -4.406950058 0.8174586 WT -0.9905050940
+#> Cell809 -5.900812282 0.8083518 WT -1.3220163888
+#> Cell1055 5.991890987 0.8808518 Mutant 1.3171596989
+#> Cell17 -2.350680759 0.8299940 WT -0.5341869096
+#> Cell683 -8.943098310 0.7898055 WT -1.9971470429
+#> Cell1848 5.072666836 0.8752480 Mutant 1.1131695426
+#> Cell746 -0.560815494 0.8409054 WT -0.1369879295
+#> Cell1517 5.372093912 0.8770734 Mutant 1.1796170744
+#> Cell969 -4.185426713 0.8188091 WT -0.9413456134
+#> Cell995 -6.917044973 0.8021567 WT -1.5475342510
+#> Cell456 2.959891273 0.8623682 WT 0.6443117382
+#> Cell223 -0.933540501 0.8386332 WT -0.2197014139
+#> Cell1719 3.982894994 0.8686046 Mutant 0.8713321973
+#> Cell680 -0.749837851 0.8397530 WT -0.1789349347
+#> Cell1046 5.927376131 0.8804585 Mutant 1.3028428475
+#> Cell1234 5.571832247 0.8782910 Mutant 1.2239421218
+#> Cell1054 2.176785408 0.8575942 Mutant 0.4705283496
+#> Cell1067 2.038782854 0.8567530 Mutant 0.4399034335
+#> Cell85 -3.751384863 0.8214551 WT -0.8450249667
+#> Cell1280 5.396265062 0.8772208 Mutant 1.1849810291
+#> Cell706 -2.085770642 0.8316090 WT -0.4753992286
+#> Cell1913 0.150922006 0.8452442 Mutant 0.0209577071
+#> Cell1416 2.954025419 0.8623324 Mutant 0.6430100137
+#> Cell1722 2.830832128 0.8615814 Mutant 0.6156715037
+#> Cell358 -0.440963717 0.8416360 WT -0.1103909536
+#> Cell1259 2.834472726 0.8616036 Mutant 0.6164794091
+#> Cell1098 6.449359090 0.8836406 Mutant 1.4186789962
+#> Cell940 -3.096027781 0.8254503 WT -0.6995910227
+#> Cell714 -3.794824327 0.8211903 WT -0.8546648603
+#> Cell1867 3.080942020 0.8631061 Mutant 0.6711747842
+#> Cell1838 5.675577294 0.8789235 Mutant 1.2469647638
+#> Cell324 1.086230534 0.8509460 WT 0.2285172373
+#> Cell659 -6.499557521 0.8047017 WT -1.4548872829
+#> Cell1154 2.090085029 0.8570657 Mutant 0.4512881850
+#> Cell1559 3.963602208 0.8684870 Mutant 0.8670508275
+#> Cell1972 6.007106990 0.8809446 Mutant 1.3205363669
+#> Cell1562 0.889541876 0.8497470 Mutant 0.1848689606
+#> Cell1527 1.242014241 0.8518957 Mutant 0.2630880683
+#> Cell1767 6.300441143 0.8827328 Mutant 1.3856317842
+#> Cell704 -8.376010765 0.7932626 WT -1.8713014842
+#> Cell1859 5.283789862 0.8765351 Mutant 1.1600210302
+#> Cell902 -2.836085918 0.8270349 WT -0.6419058746
+#> Cell303 -3.304543819 0.8241791 WT -0.7458639793
+#> Cell1360 4.236161257 0.8701486 Mutant 0.9275359258
+#> Cell901 -6.761271589 0.8031063 WT -1.5129657108
+#> Cell1986 2.029917486 0.8566989 Mutant 0.4379360702
+#> Cell853 -8.193048412 0.7943779 WT -1.8306992882
+#> Cell881 -4.081652166 0.8194417 WT -0.9183164250
+#> Cell99 -3.397826655 0.8236104 WT -0.7665648935
+#> Cell133 1.620048292 0.8542003 WT 0.3469797122
+#> Cell723 -3.242267624 0.8245588 WT -0.7320439215
+#> Cell894 -3.946585894 0.8202651 WT -0.8883431156
+#> Cell1785 3.484115328 0.8655640 Mutant 0.7606452209
+#> Cell859 -3.457021405 0.8232496 WT -0.7797011305
+#> Cell635 -3.675395765 0.8219183 WT -0.8281618023
+#> Cell530 -5.663248662 0.8098000 WT -1.2692973214
+#> Cell1384 5.632130393 0.8786586 Mutant 1.2373232197
+#> Cell711 -5.373538554 0.8115662 WT -1.2050061360
+#> Cell1117 3.183318917 0.8637303 Mutant 0.6938938123
+#> Cell1953 2.223310056 0.8578779 Mutant 0.4808528936
+#> Cell1970 5.304286040 0.8766600 Mutant 1.1645694514
+#> Cell112 -4.408376761 0.8174499 WT -0.9908217015
+#> Cell1149 2.027098930 0.8566817 Mutant 0.4373105887
+#> Cell1907 6.688858104 0.8851006 Mutant 1.4718275576
+#> Cell464 -5.695608982 0.8096028 WT -1.2764785804
+#> Cell1940 5.301887782 0.8766454 Mutant 1.1640372408
+#> Cell88 0.732908415 0.8487921 WT 0.1501095559
+#> Cell300 -5.669291659 0.8097632 WT -1.2706383564
+#> Cell1272 5.116512926 0.8755153 Mutant 1.1228996728
+#> Cell546 -4.931889245 0.8142585 WT -1.1069972756
+#> Cell1289 2.195212284 0.8577066 Mutant 0.4746175603
+#> Cell1845 1.927293666 0.8560733 Mutant 0.4151622461
+#> Cell1303 8.129755968 0.8938846 Mutant 1.7915852361
+#> Cell143 -3.802415059 0.8211440 WT -0.8563493619
+#> Cell254 -11.821139992 0.7722604 WT -2.6358293184
+#> Cell967 -3.683881418 0.8218666 WT -0.8300449006
+#> Cell576 -1.821673860 0.8332189 WT -0.4167920391
+#> Cell507 -2.010882268 0.8320655 WT -0.4587803320
+#> Cell1152 3.953152029 0.8684233 Mutant 0.8647317701
+#> Cell889 -3.710332619 0.8217053 WT -0.8359148341
+#> Cell724 -6.680320560 0.8035998 WT -1.4950014168
+#> Cell1749 1.378398146 0.8527271 Mutant 0.2933537809
+#> Cell763 -4.302723030 0.8180940 WT -0.9673754931
+#> Cell1452 2.978714870 0.8624829 Mutant 0.6484889875
+#> Cell1631 1.757163092 0.8550362 Mutant 0.3774076219
+#> Cell984 -3.434538516 0.8233866 WT -0.7747118271
+#> Cell1764 1.165758292 0.8514308 Mutant 0.2461656853
+#> Cell1500 5.235601708 0.8762413 Mutant 1.1493273284
+#> Cell348 -5.346972310 0.8117281 WT -1.1991106727
+#> Cell1215 1.445845222 0.8531383 Mutant 0.3083213376
+#> Cell1409 3.526213855 0.8658206 Mutant 0.7699875397
+#> Cell947 -7.166447374 0.8006363 WT -1.6028805282
+#> Cell666 -7.208716316 0.8003786 WT -1.6122606648
+#> Cell1174 2.068746807 0.8569356 Mutant 0.4465529011
+#> Cell151 -0.572379126 0.8408349 WT -0.1395540797
+#> Cell1492 1.367946705 0.8526634 Mutant 0.2910344434
+#> Cell1924 6.397851594 0.8833266 Mutant 1.4072486805
+#> Cell1042 4.025797012 0.8688661 Mutant 0.8808528234
+#> Cell1022 4.698735640 0.8729685 Mutant 1.0301883862
+#> Cell791 -1.696228020 0.8339837 WT -0.3889536534
+#> Cell1987 2.053340096 0.8568417 Mutant 0.4431339121
+#> Cell2 -3.233870458 0.8246099 WT -0.7301804596
+#> Cell214 -4.912004476 0.8143797 WT -1.1025845356
+#> Cell932 -3.111385365 0.8253566 WT -0.7029991098
+#> Cell1195 9.364763592 0.9014134 Mutant 2.0656526633
+#> Cell1307 1.940139376 0.8561516 Mutant 0.4180129092
+#> Cell1981 1.140097065 0.8512744 Mutant 0.2404710594
+#> Cell419 -4.062967220 0.8195556 WT -0.9141699446
+#> Cell1200 1.760294236 0.8550552 Mutant 0.3781024714
+#> Cell664 -3.982899016 0.8200437 WT -0.8964015630
+#> Cell1254 1.907233009 0.8559510 Mutant 0.4107104738
+#> Cell567 -2.598860737 0.8284811 WT -0.5892619120
+#> Cell50 -4.688545222 0.8157420 WT -1.0529954468
+#> Cell836 -9.744687236 0.7849189 WT -2.1750321105
+#> Cell1833 2.826915372 0.8615576 Mutant 0.6148023146
+#> Cell1026 5.000829242 0.8748101 Mutant 1.0972276616
+#> Cell682 -15.619162048 0.7491070 WT -3.4786695678
+#> Cell382 -10.155737059 0.7824130 WT -2.2662504684
+#> Cell137 0.100640586 0.8449377 WT 0.0097994769
+#> Cell77 -0.238754312 0.8428687 WT -0.0655175370
+#> Cell800 -3.810777707 0.8210930 WT -0.8582051636
+#> Cell78 -2.645891301 0.8281944 WT -0.5996987267
+#> Cell1064 2.865408979 0.8617922 Mutant 0.6233446453
+#> Cell1647 4.868470780 0.8740032 Mutant 1.0678552573
+#> Cell1994 0.583609639 0.8478820 Mutant 0.1169778323
+#> Cell1978 6.962061096 0.8867661 Mutant 1.5324555566
+#> Cell1377 3.954077099 0.8684289 Mutant 0.8649370576
+#> Cell497 -4.234679356 0.8185088 WT -0.9522755420
+#> Cell1084 3.509317153 0.8657176 Mutant 0.7662378983
+#> Cell775 -1.172671324 0.8371754 WT -0.2727682680
+#> Cell60 2.145432360 0.8574031 WT 0.4635706198
+#> Cell357 -0.487277800 0.8413537 WT -0.1206687698
+#> Cell740 -3.228914475 0.8246402 WT -0.7290806499
+#> Cell1950 4.048628446 0.8690053 Mutant 0.8859194740
+#> Cell717 -6.758334946 0.8031242 WT -1.5123140241
+#> Cell589 -5.908401009 0.8083055 WT -1.3237004454
+#> Cell1417 0.547208312 0.8476601 Mutant 0.1088998107
+#> Cell935 -6.498382765 0.8047089 WT -1.4546265863
+#> Cell1855 0.108139910 0.8449834 Mutant 0.0114636938
+#> Cell1350 5.012268485 0.8748798 Mutant 1.0997662078
+#> Cell138 -0.831108216 0.8392576 WT -0.1969700945
+#> Cell1746 0.861889372 0.8495784 Mutant 0.1787324394
+#> Cell892 0.061091298 0.8446966 WT 0.0010228741
+#> Cell1342 3.893843524 0.8680617 Mutant 0.8515702891
+#> Cell1679 9.559372710 0.9025998 Mutant 2.1088394578
+#> Cell1516 2.401470418 0.8589640 Mutant 0.5203894528
+#> Cell526 -2.282387097 0.8304104 WT -0.5190314822
+#> Cell1470 4.120203300 0.8694417 Mutant 0.9018030491
+#> Cell1281 1.556337813 0.8538119 Mutant 0.3328413646
+#> Cell910 -4.453910428 0.8171724 WT -1.0009263314
+#> Cell1311 3.189515739 0.8637680 Mutant 0.6952689836
+#> Cell1599 0.326556684 0.8463149 Mutant 0.0599337779
+#> Cell367 -5.155110321 0.8128977 WT -1.1565335092
+#> Cell1057 3.508826647 0.8657146 Mutant 0.7661290474
+#> Cell903 -0.893706855 0.8388760 WT -0.2108617074
+#> Cell559 -4.417421260 0.8173948 WT -0.9928288167
+#> Cell1107 1.434083425 0.8530666 Mutant 0.3057112118
+#> Cell1341 6.737707834 0.8853984 Mutant 1.4826680734
+#> Cell277 -8.239001362 0.7940978 WT -1.8408969636
+#> Cell612 -5.328572569 0.8118403 WT -1.1950274836
+#> Cell1129 5.002101720 0.8748179 Mutant 1.0975100442
+#> Cell385 -5.286338654 0.8120977 WT -1.1856551202
+#> Cell1998 2.131249125 0.8573166 Mutant 0.4604231392
+#> Cell1455 3.346601949 0.8647257 Mutant 0.7301288603
+#> Cell1475 2.560436774 0.8599331 Mutant 0.5556665630
+#> Cell611 -0.386231572 0.8419696 WT -0.0982450380
+#> Cell1498 4.065121534 0.8691059 Mutant 0.8895795473
+#> Cell111 -3.382416008 0.8237044 WT -0.7631450307
+#> Cell1759 5.097750834 0.8754010 Mutant 1.1187360724
+#> Cell1791 1.478847999 0.8533395 Mutant 0.3156451679
+#> Cell1963 0.846420719 0.8494841 Mutant 0.1752997042
+#> Cell695 -2.691012660 0.8279193 WT -0.6097118591
+#> Cell1780 2.640759568 0.8604227 Mutant 0.5734914422
+#> Cell1328 6.043100793 0.8811640 Mutant 1.3285239525
+#> Cell424 -3.293794843 0.8242446 WT -0.7434786141
+#> Cell239 -10.634235037 0.7794960 WT -2.3724366226
+#> Cell678 -9.490203543 0.7864702 WT -2.1185582154
+#> Cell614 -0.142209557 0.8434572 WT -0.0440927523
+#> Cell1001 3.775664784 0.8673413 Mutant 0.8253445861
+#> Cell266 -2.255521151 0.8305741 WT -0.5130695103
+#> Cell1914 -0.048914808 0.8440260 Mutant -0.0233891943
+#> Cell154 -0.807224957 0.8394032 WT -0.1916700272
+#> Cell652 -9.557329415 0.7860610 WT -2.1334544918
+#> Cell712 -10.507526220 0.7802685 WT -2.3443179624
+#> Cell937 -8.115943055 0.7948480 WT -1.8135884085
+#> Cell1428 4.569222518 0.8721790 Mutant 1.0014474071
+#> Cell453 0.058585269 0.8446813 WT 0.0004667472
+#> Cell420 -1.141746369 0.8373639 WT -0.2659055388
+#> Cell56 -4.258388181 0.8183643 WT -0.9575368996
+#> Cell400 1.193808566 0.8516018 WT 0.2523904781
+#> Cell551 0.026048725 0.8444830 WT -0.0067536188
+#> Cell116 -6.671552889 0.8036532 WT -1.4930557340
+#> Cell89 0.384392202 0.8466675 WT 0.0727683801
+#> Cell591 -0.659384246 0.8403045 WT -0.1588618709
+#> Cell874 -5.906678186 0.8083160 WT -1.3233181243
+#> Cell1177 3.311328457 0.8645106 Mutant 0.7223011229
+#> Cell115 -6.727406157 0.8033127 WT -1.5054504440
+#> Cell1777 2.777922458 0.8612589 Mutant 0.6039300237
+#> Cell1534 3.129268837 0.8634008 Mutant 0.6818992576
+#> Cell432 -2.566191475 0.8286802 WT -0.5820120940
+#> Cell1334 2.635727875 0.8603920 Mutant 0.5723748312
+#> Cell413 -3.506912037 0.8229454 WT -0.7907726386
+#> Cell45 -5.352630642 0.8116936 WT -1.2003663448
+#> Cell716 1.983219917 0.8564142 WT 0.4275731522
+#> Cell997 -0.514120401 0.8411900 WT -0.1266255612
+#> Cell1873 6.854802779 0.8861123 Mutant 1.5086532657
+#> Cell1353 3.306925882 0.8644838 Mutant 0.7213241230
+#> Cell1094 4.435874195 0.8713660 Mutant 0.9718553374
+#> Cell370 -4.745255154 0.8153963 WT -1.0655802639
+#> Cell692 -3.653688004 0.8220507 WT -0.8233445119
+#> Cell1140 4.764270671 0.8733680 Mutant 1.0447316303
+#> Cell1899 1.443446450 0.8531237 Mutant 0.3077890127
+#> Cell868 -4.173767705 0.8188802 WT -0.9387582978
+#> Cell1663 5.278786608 0.8765046 Mutant 1.1589107304
+#> Cell484 -2.890246707 0.8267047 WT -0.6539249972
+#> Cell1682 3.398664796 0.8650430 Mutant 0.7416824169
+#> Cell602 -2.460269547 0.8293259 WT -0.5585063685
+#> Cell1494 3.751850387 0.8671961 Mutant 0.8200598005
+#> Cell142 -2.087740416 0.8315970 WT -0.4758363521
+#> Cell21 -6.450239979 0.8050024 WT -1.4439429522
+#> Cell1816 3.808554282 0.8675418 Mutant 0.8326432779
+#> Cell198 -1.845842561 0.8330716 WT -0.4221554504
+#> Cell1974 2.421794769 0.8590879 Mutant 0.5248997429
+#> Cell1758 1.074573451 0.8508750 Mutant 0.2259303489
+#> Cell621 -4.709343129 0.8156152 WT -1.0576108263
+#> Cell735 -8.851880477 0.7903616 WT -1.9769043849
+#> Cell629 1.547000648 0.8537550 WT 0.3307693022
+#> Cell1980 4.728021607 0.8731470 Mutant 1.0366873982
+#> Cell627 -1.502393528 0.8351653 WT -0.3459387606
+#> Cell1700 2.897869742 0.8619901 Mutant 0.6305481943
+#> Cell1071 4.395256069 0.8711184 Mutant 0.9628415425
+#> Cell679 -6.261440182 0.8061533 WT -1.4020453366
+#> Cell1900 2.649728265 0.8604774 Mutant 0.5754817357
+#> Cell1404 3.778424219 0.8673581 Mutant 0.8259569478
+#> Cell767 -2.521966609 0.8289498 WT -0.5721979075
+#> Cell590 -1.310648365 0.8363342 WT -0.3033875226
+#> Cell11 -0.776900605 0.8395881 WT -0.1849405813
+#> Cell1581 3.557353795 0.8660104 Mutant 0.7768979773
+#> Cell552 -2.475870473 0.8292308 WT -0.5619684569
+#> Cell653 -3.546061522 0.8227068 WT -0.7994605192
+#> Cell899 -4.974173033 0.8140008 WT -1.1163807068
+#> Cell473 -1.812677052 0.8332738 WT -0.4147955074
+#> Cell342 -5.726944502 0.8094117 WT -1.2834324204
+#> Cell1044 3.470057348 0.8654783 Mutant 0.7575255362
+#> Cell795 -9.785980590 0.7846671 WT -2.1841957488
+#> Cell1975 1.654986644 0.8544133 Mutant 0.3547330766
+#> Cell1554 4.014636943 0.8687981 Mutant 0.8783762301
+#> Cell314 -5.036891700 0.8136184 WT -1.1302989558
+#> Cell411 -0.952210539 0.8385193 WT -0.2238445861
+#> Cell926 -5.424036557 0.8112583 WT -1.2162124295
+#> Cell1555 3.980261752 0.8685886 Mutant 0.8707478400
+#> Cell488 -1.920004682 0.8326195 WT -0.4386131801
+#> Cell1291 3.124824368 0.8633737 Mutant 0.6809129607
+#> Cell888 -2.136139859 0.8313019 WT -0.4865769423
+#> Cell555 -3.771045227 0.8213352 WT -0.8493879075
+#> Cell593 -7.251074364 0.8001204 WT -1.6216605756
+#> Cell1773 5.400549957 0.8772469 Mutant 1.1859319139
+#> Cell540 -3.718339001 0.8216565 WT -0.8376915750
+#> Cell355 -6.682578655 0.8035860 WT -1.4955025232
+#> Cell1834 5.053115015 0.8751289 Mutant 1.1088306889
+#> Cell1760 5.904522419 0.8803192 Mutant 1.2977712528
+#> Cell262 5.023204132 0.8749465 WT 1.1021929982
+#> Cell1872 7.147271994 0.8878952 Mutant 1.5735567396
+#> Cell341 -6.436180158 0.8050881 WT -1.4408228589
+#> Cell871 -4.625525939 0.8161262 WT -1.0390104864
+#> Cell1811 4.128181981 0.8694903 Mutant 0.9035736426
+#> Cell1520 7.467827523 0.8898494 Mutant 1.6446930043
+#> Cell31 -4.871163777 0.8146287 WT -1.0935213485
+#> Cell1198 -0.024338708 0.8441758 Mutant -0.0179353748
+#> Cell165 0.034820310 0.8445365 WT -0.0048070674
+#> Cell351 -1.856948261 0.8330039 WT -0.4246199783
+#> Cell490 -5.571304829 0.8103605 WT -1.2488935528
+#> Cell235 -2.812617125 0.8271780 WT -0.6366977839
+#> Cell537 -7.486860184 0.7986830 WT -1.6739851214
+#> Cell1992 2.356146096 0.8586877 Mutant 0.5103312798
+#> Cell987 -4.694070759 0.8157083 WT -1.0542216495
+#> Cell1326 7.322040020 0.8889606 Mutant 1.6123404868
+#> Cell1985 4.174432303 0.8697723 Mutant 0.9138373094
+#> Cell1522 0.041947113 0.8445799 Mutant -0.0032255188
+#> Cell776 1.245328889 0.8519159 WT 0.2638236403
+#> Cell1299 5.007456610 0.8748505 Mutant 1.0986983777
+#> Cell780 -7.327076574 0.7996570 WT -1.6385266497
+#> Cell1242 5.920307424 0.8804154 Mutant 1.3012741913
+#> Cell1162 15.275956795 0.9374491 Mutant 3.3774385037
+#> Cell156 -5.835136005 0.8087522 WT -1.3074418001
+#> Cell1720 6.228643504 0.8822951 Mutant 1.3696987698
+#> Cell1004 4.473263046 0.8715940 Mutant 0.9801525057
+#> Cell261 -4.153011791 0.8190067 WT -0.9341522372
+#> Cell19 -1.838533509 0.8331162 WT -0.4205334579
+#> Cell1007 3.175780033 0.8636843 Mutant 0.6922208165
+#> Cell1571 1.297413567 0.8522334 Mutant 0.2753820415
+#> Cell241 -2.079388194 0.8316479 WT -0.4739828639
+#> Cell23 -4.026702684 0.8197767 WT -0.9061222791
+#> Cell479 -0.809253055 0.8393908 WT -0.1921200938
+#> Cell1502 2.014902383 0.8566074 Mutant 0.4346039848
+#> Cell793 -5.820650203 0.8088405 WT -1.3042271749
+#> Cell1233 0.072723424 0.8447675 Mutant 0.0036042239
+#> Cell1225 3.467461695 0.8654624 Mutant 0.7569495203
+#> Cell681 -1.126704466 0.8374556 WT -0.2625675064
+#> Cell466 -3.171647976 0.8249893 WT -0.7163723217
+#> Cell953 -4.987645736 0.8139186 WT -1.1193705094
+#> Cell883 -7.844705460 0.7965015 WT -1.7533965617
+#> Cell1316 4.212488564 0.8700042 Mutant 0.9222825864
+#> Cell1551 3.317191571 0.8645464 Mutant 0.7236022393
+#> Cell709 -5.325916399 0.8118565 WT -1.1944380382
+#> Cell756 -6.979195608 0.8017778 WT -1.5613264449
+#> Cell1661 2.551152069 0.8598765 Mutant 0.5536061424
+#> Cell1850 6.015278163 0.8809944 Mutant 1.3223496774
+#> Cell1380 1.748232977 0.8549817 Mutant 0.3754258903
+#> Cell1491 1.250303149 0.8519462 Mutant 0.2649275061
+#> Cell1402 1.490358774 0.8534097 Mutant 0.3181995880
+#> Cell292 -3.776034353 0.8213048 WT -0.8504950724
+#> Cell1763 3.105260120 0.8632544 Mutant 0.6765713493
+#> Cell906 -6.802976151 0.8028520 WT -1.5222206028
+#> Cell425 -1.153364618 0.8372931 WT -0.2684838092
+#> Cell1645 6.078817314 0.8813817 Mutant 1.3364500048
+#> Cell988 -0.394671502 0.8419182 WT -0.1001179900
+#> Cell240 -4.852682311 0.8147414 WT -1.0894200234
+#> Cell865 -1.093209811 0.8376598 WT -0.2551345206
+#> Cell1979 2.498944249 0.8595582 Mutant 0.5420204141
+#> Cell1265 3.423274516 0.8651931 Mutant 0.7471436970
+#> Cell1095 5.188361105 0.8759533 Mutant 1.1388439027
+#> Cell371 -3.629257525 0.8221996 WT -0.8179230082
+#> Cell1261 3.140156776 0.8634671 Mutant 0.6843154608
+#> Cell1861 3.946410700 0.8683822 Mutant 0.8632357643
+#> Cell1262 5.147295719 0.8757030 Mutant 1.1297308540
+#> Cell1835 13.846165393 0.9287328 Mutant 3.0601455221
+#> Cell1504 4.774665695 0.8734314 Mutant 1.0470384479
+#> Cell1277 0.425918039 0.8469207 Mutant 0.0819836100
+#> Cell1069 2.830607318 0.8615801 Mutant 0.6156216148
+#> Cell282 -0.185729949 0.8431919 WT -0.0537506051
+#> Cell1687 2.846559163 0.8616773 Mutant 0.6191615777
+#> Cell1462 3.681620800 0.8667680 Mutant 0.8044747613
+#> Cell296 -0.231618210 0.8429122 WT -0.0639339249
+#> Cell1615 4.125922304 0.8694765 Mutant 0.9030721852
+#> Cell1642 4.107392394 0.8693636 Mutant 0.8989601094
+#> Cell1058 1.602222338 0.8540916 Mutant 0.3430238553
+#> Cell1382 11.106750952 0.9120329 Mutant 2.4522267906
+#> Cell1863 1.380145627 0.8527378 Mutant 0.2937415743
+#> Cell1874 3.101145970 0.8632293 Mutant 0.6756583553
+#> Cell545 -7.284642173 0.7999157 WT -1.6291097951
+#> Cell1602 7.101674613 0.8876172 Mutant 1.5634379706
+#> Cell315 -6.550498883 0.8043912 WT -1.4661919645
+#> Cell234 -3.633526114 0.8221736 WT -0.8188702744
+#> Cell207 -3.414598984 0.8235082 WT -0.7702869344
+#> Cell428 1.654634415 0.8544111 WT 0.3546549115
+#> Cell1252 3.909414471 0.8681567 Mutant 0.8550257248
+#> Cell1247 5.830726234 0.8798693 Mutant 1.2813947301
+#> Cell1160 3.424894376 0.8652029 Mutant 0.7475031692
+#> Cell1941 8.133612240 0.8939081 Mutant 1.7924410029
+#> Cell702 -3.037891256 0.8258047 WT -0.6866896223
+#> Cell383 -0.176840852 0.8432461 WT -0.0517779759
+#> Cell1304 1.633185934 0.8542804 Mutant 0.3498951595
+#> Cell1143 1.242506854 0.8518987 Mutant 0.2631973867
+#> Cell1314 3.080107203 0.8631011 Mutant 0.6709895254
+#> Cell1239 4.381676892 0.8710357 Mutant 0.9598281116
+#> Cell489 -5.886958016 0.8084363 WT -1.3189419113
+#> Cell1836 6.476656991 0.8838070 Mutant 1.4247368254
+#> Cell1876 2.297688737 0.8583313 Mutant 0.4973586813
+#> Cell1825 5.698392985 0.8790626 Mutant 1.2520279208
+#> Cell582 -4.669245352 0.8158596 WT -1.0487125050
+#> Cell1839 3.499143738 0.8656556 Mutant 0.7639802590
+#> Cell1629 6.003907428 0.8809251 Mutant 1.3198263344
+#> Cell1219 1.951349455 0.8562199 Mutant 0.4205006003
+#> Cell1880 5.570869320 0.8782852 Mutant 1.2237284334
+#> Cell1523 3.532187127 0.8658570 Mutant 0.7713131016
+#> Cell1885 3.339473980 0.8646822 Mutant 0.7285470528
+#> Cell1693 4.442913860 0.8714090 Mutant 0.9734175487
+#> Cell283 -3.498849163 0.8229946 WT -0.7889833614
+#> Cell729 -2.750616411 0.8275559 WT -0.6229388597
+#> Cell511 -2.155099788 0.8311863 WT -0.4907844459
+#> Cell1374 0.964534689 0.8502042 Mutant 0.2015110338
+#> Cell580 -2.048648719 0.8318353 WT -0.4671612956
+#> Cell919 -3.896412807 0.8205710 WT -0.8772089262
+#> Cell1699 6.279597284 0.8826057 Mutant 1.3810062073
+#> Cell448 -3.801550021 0.8211493 WT -0.8561573964
+#> Cell1828 3.585429849 0.8661816 Mutant 0.7831284910
+#> Cell1486 5.961690831 0.8806677 Mutant 1.3104578139
+#> Cell918 -6.040228357 0.8075019 WT -1.3529549872
+#> Cell252 -2.419736570 0.8295730 WT -0.5495114696
+#> Cell1765 5.540451717 0.8780997 Mutant 1.2169782935
+#> Cell476 -4.177007796 0.8188604 WT -0.9394773246
+#> Cell1776 1.729878582 0.8548698 Mutant 0.3713527642
+#> Cell792 0.351297177 0.8464658 WT 0.0654240785
+#> Cell1662 1.879104760 0.8557795 Mutant 0.4044683772
+#> Cell999 -2.091833036 0.8315720 WT -0.4767445681
+#> Cell1640 4.442638194 0.8714073 Mutant 0.9733563739
+#> Cell818 -4.657221726 0.8159329 WT -1.0460442751
+#> Cell977 -1.739451754 0.8337202 WT -0.3985456732
+#> Cell62 -0.281411435 0.8426086 WT -0.0749838170
+#> Cell799 -5.265791163 0.8122230 WT -1.1810953119
+#> Cell1134 2.105606874 0.8571603 Mutant 0.4547327241
+#> Cell1401 2.894139844 0.8619674 Mutant 0.6297204719
+#> Cell394 -0.103762019 0.8436916 WT -0.0355606448
+#> Cell1927 2.706802454 0.8608253 Mutant 0.5881473871
+#> Cell386 -7.252081435 0.8001142 WT -1.6218840602
+#> Cell1016 2.199874571 0.8577350 Mutant 0.4756521944
+#> Cell1373 1.515290594 0.8535617 Mutant 0.3237323474
+#> Cell1115 9.267986870 0.9008235 Mutant 2.0441764015
+#> Cell643 -1.480602819 0.8352982 WT -0.3411030629
+#> Cell427 -4.258967060 0.8183608 WT -0.9576653618
+#> Cell1419 4.320443641 0.8706624 Mutant 0.9462394996
+#> Cell1120 3.633496572 0.8664746 Mutant 0.7937952455
+#> Cell1860 4.646908934 0.8726526 Mutant 1.0186872327
+#> Cell1625 4.033234714 0.8689115 Mutant 0.8825033652
+#> Cell1906 5.587828215 0.8783886 Mutant 1.2274918763
+#> Cell572 -2.332036211 0.8301077 WT -0.5300493939
+#> Cell418 -4.854737845 0.8147289 WT -1.0898761784
+#> Cell52 -1.284232694 0.8364953 WT -0.2975254736
+#> Cell1369 4.761970315 0.8733540 Mutant 1.0442211453
+#> Cell43 -1.665190365 0.8341729 WT -0.3820659144
+#> Cell1752 1.768542555 0.8551055 Mutant 0.3799329019
+#> Cell966 -0.355312618 0.8421581 WT -0.0913836405
+#> Cell345 -5.556627599 0.8104500 WT -1.2456364469
+#> Cell1696 3.058323672 0.8629683 Mutant 0.6661554205
+#> Cell1652 4.532720052 0.8719564 Mutant 0.9933469415
+#> Cell520 -3.978581545 0.8200701 WT -0.8954434489
+#> Cell925 0.607722374 0.8480290 WT 0.1223288236
+#> Cell1124 0.545420052 0.8476492 Mutant 0.1085029680
+#> Cell914 -1.350891874 0.8360889 WT -0.3123181839
+#> Cell470 -1.666420926 0.8341654 WT -0.3823389951
+#> Cell1653 2.983144898 0.8625100 Mutant 0.6494720795
+#> Cell660 -5.533604488 0.8105904 WT -1.2405272600
+#> Cell1251 2.525551995 0.8597204 Mutant 0.5479250873
+#> Cell273 -2.541049635 0.8288335 WT -0.5764327281
+#> Cell1080 4.900859541 0.8742007 Mutant 1.0750428279
+#> Cell206 -7.439508308 0.7989716 WT -1.6634770027
+#> Cell584 -6.808329098 0.8028194 WT -1.5234085050
+#> Cell1108 2.985325742 0.8625232 Mutant 0.6499560429
+#> Cell193 -6.290202627 0.8059780 WT -1.4084281713
+#> Cell1868 5.307150607 0.8766775 Mutant 1.1652051435
+#> Cell1635 5.823154811 0.8798232 Mutant 1.2797145134
+#> Cell983 -3.723057736 0.8216278 WT -0.8387387360
+#> Cell971 0.363067257 0.8465375 WT 0.0680360426
+#> Cell897 -7.292057075 0.7998705 WT -1.6307552773
+#> Cell1853 3.784066537 0.8673925 Mutant 0.8272090659
+#> Cell209 -5.794884025 0.8089976 WT -1.2985092587
+#> Cell1049 2.646390742 0.8604570 Mutant 0.5747410875
+#> Cell431 -4.766562285 0.8152664 WT -1.0703086482
+#> Cell1608 4.161314948 0.8696923 Mutant 0.9109263640
+#> Cell1092 3.474113297 0.8655030 Mutant 0.7584256143
+#> Cell993 -4.008546396 0.8198874 WT -0.9020931162
+#> Cell885 -3.069706560 0.8256107 WT -0.6937499337
+#> Cell1611 3.941651249 0.8683532 Mutant 0.8621795679
+#> Cell1186 4.642131394 0.8726234 Mutant 1.0176270222
+#> Cell1710 1.439352274 0.8530987 Mutant 0.3068804513
+#> Cell1338 7.100033839 0.8876072 Mutant 1.5630738573
+#> Cell294 -4.536028619 0.8166718 WT -1.0191496371
+#> Cell397 -2.791427786 0.8273071 WT -0.6319955395
+#> Cell649 -2.486284874 0.8291674 WT -0.5642795748
+#> Cell463 0.626907589 0.8481459 WT 0.1265863216
+#> Cell733 -2.432107455 0.8294976 WT -0.5522567616
+#> Cell1194 4.550708535 0.8720661 Mutant 0.9973388659
+#> Cell1141 4.331805821 0.8707316 Mutant 0.9487609443
+#> Cell1284 3.973831407 0.8685494 Mutant 0.8693208462
+#> Cell125 -3.022338823 0.8258995 WT -0.6832382953
+#> Cell454 -5.030830878 0.8136554 WT -1.1289539650
+#> Cell1312 4.927209427 0.8743613 Mutant 1.0808902779
+#> Cell1904 2.783401789 0.8612923 Mutant 0.6051459728
+#> Cell1359 1.143667121 0.8512962 Mutant 0.2412633106
+#> Cell642 -10.787807556 0.7785598 WT -2.4065167564
+#> Cell1403 3.422878758 0.8651906 Mutant 0.7470558722
+#> Cell1473 4.643146162 0.8726296 Mutant 1.0178522151
+#> Cell1362 7.477612519 0.8899090 Mutant 1.6468644473
+#> Cell846 -3.211293511 0.8247476 WT -0.7251702835
+#> Cell377 -2.669592074 0.8280499 WT -0.6049582975
+#> Cell1499 4.025919231 0.8688669 Mutant 0.8808799456
+#> Cell1990 4.541059016 0.8720073 Mutant 0.9951974874
+#> Cell1375 3.475646546 0.8655123 Mutant 0.7587658662
+#> Cell164 -4.979041263 0.8139711 WT -1.1174610428
+#> Cell1704 0.755357181 0.8489290 Mutant 0.1550912868
+#> Cell1121 3.451297325 0.8653639 Mutant 0.7533623948
+#> Cell1019 3.476952031 0.8655203 Mutant 0.7590555736
+#> Cell522 -0.884250153 0.8389336 WT -0.2087631179
+#> Cell1683 2.768361863 0.8612006 Mutant 0.6018083789
+#> Cell1103 2.058576228 0.8568736 Mutant 0.4442958914
+#> Cell817 -1.818904432 0.8332358 WT -0.4161774601
+#> Cell1946 2.947395620 0.8622920 Mutant 0.6415387581
+#> Cell1808 2.902629649 0.8620191 Mutant 0.6316044919
+#> Cell1717 1.495558768 0.8534414 Mutant 0.3193535477
+#> Cell160 -17.008134662 0.7406396 WT -3.7869042246
+#> Cell4 -3.185460954 0.8249051 WT -0.7194376367
+#> Cell1133 3.403061224 0.8650698 Mutant 0.7426580526
+#> Cell668 0.451937019 0.8470793 WT 0.0877576271
+#> Cell336 -1.709403217 0.8339034 WT -0.3918774349
+#> Cell569 -2.367582856 0.8298910 WT -0.5379377480
+#> Cell53 -3.020889616 0.8259083 WT -0.6829166935
+#> Cell1003 3.231104710 0.8640216 Mutant 0.7044982240
+#> Cell51 -8.688829444 0.7913556 WT -1.9407208212
+#> Cell708 -4.752707602 0.8153508 WT -1.0672340783
+#> Cell1879 8.050219330 0.8933997 Mutant 1.7739348172
+#> Cell270 -6.929098429 0.8020832 WT -1.5502091007
+#> Cell1706 3.245238002 0.8641077 Mutant 0.7076346216
+#> Cell833 -1.010919761 0.8381614 WT -0.2368730769
+#> Cell554 -5.919187489 0.8082398 WT -1.3260941334
+#> Cell1230 3.976274617 0.8685642 Mutant 0.8698630326
+#> Cell1666 6.511467199 0.8840192 Mutant 1.4324617528
+#> Cell264 -6.752699428 0.8031585 WT -1.5110634149
+#> Cell66 -7.957103867 0.7958163 WT -1.7783395188
+#> Cell1889 1.968309532 0.8563233 Mutant 0.4242643056
+#> Cell1203 3.828078760 0.8676608 Mutant 0.8369760637
+#> Cell380 -1.936682721 0.8325178 WT -0.4423142968
+#> Cell228 -5.412731449 0.8113272 WT -1.2137036499
+#> Cell1782 7.481669221 0.8899337 Mutant 1.6477646928
+#> Cell826 -4.623204330 0.8161403 WT -1.0384952851
+#> Cell813 -0.924220632 0.8386900 WT -0.2176331898
+#> Cell1323 5.078190364 0.8752817 Mutant 1.1143952995
+#> Cell1431 2.977148190 0.8624734 Mutant 0.6481413167
+#> Cell1510 6.310529553 0.8827943 Mutant 1.3878705596
+#> Cell1438 6.218522162 0.8822334 Mutant 1.3674526864
+#> Cell322 -3.356956160 0.8238596 WT -0.7574950941
+#> Cell1153 2.156117527 0.8574683 Mutant 0.4659418248
+#> Cell393 -4.865024568 0.8146661 WT -1.0921589624
+#> Cell922 -5.324163739 0.8118671 WT -1.1940490955
+#> Cell1197 2.187650752 0.8576605 Mutant 0.4729395386
+#> Cell862 -3.828964369 0.8209821 WT -0.8622410672
+#> Cell487 -8.270615542 0.7939051 WT -1.8479126425
+#> Cell211 -6.258158846 0.8061734 WT -1.4013171571
+#> Cell1944 3.031898290 0.8628072 Mutant 0.6602912167
+#> Cell1139 7.321685944 0.8889585 Mutant 1.6122619117
+#> Cell1945 1.111526703 0.8511002 Mutant 0.2341308512
+#> Cell1192 2.834216702 0.8616021 Mutant 0.6164225934
+#> Cell1538 4.116599390 0.8694197 Mutant 0.9010032853
+#> Cell1214 2.423492377 0.8590982 Mutant 0.5252764684
+#> Cell1703 1.786449880 0.8552147 Mutant 0.3839068163
+#> Cell563 -3.049524846 0.8257337 WT -0.6892712972
+#> Cell1691 2.841200832 0.8616446 Mutant 0.6179724806
+#> Cell779 -5.609980749 0.8101248 WT -1.2574763418
+#> Cell1903 5.533058549 0.8780547 Mutant 1.2153376345
+#> Cell333 -4.508183107 0.8168415 WT -1.0129702842
+#> Cell1406 5.643447371 0.8787276 Mutant 1.2398346333
+#> Cell513 -1.625009731 0.8344178 WT -0.3731492059
+#> Cell1996 1.513606487 0.8535514 Mutant 0.3233586177
+#> Cell3 -1.776181872 0.8334963 WT -0.4066966585
+#> Cell82 -5.658418037 0.8098295 WT -1.2682253304
+#> Cell1506 4.107172133 0.8693622 Mutant 0.8989112301
+#> Cell909 -1.281301422 0.8365131 WT -0.2968749788
+#> Cell1243 2.913179222 0.8620834 Mutant 0.6339456063
+#> Cell1891 4.502614465 0.8717729 Mutant 0.9866660426
+#> Cell1820 3.898603277 0.8680907 Mutant 0.8526265524
+#> Cell1188 2.790112421 0.8613332 Mutant 0.6066351666
+#> Cell373 -5.618769097 0.8100712 WT -1.2594266131
+#> Cell187 -2.116925824 0.8314190 WT -0.4823130486
+#> Cell1315 2.078345676 0.8569941 Mutant 0.4486830399
+#> Cell941 -8.557644069 0.7921553 WT -1.9116087432
+#> Cell291 -11.522235113 0.7740826 WT -2.5694976702
+#> Cell403 -5.153906399 0.8129051 WT -1.1562663401
+#> Cell1540 4.171761897 0.8697560 Mutant 0.9132447048
+#> Cell979 -2.019439498 0.8320133 WT -0.4606793145
+#> Cell1890 4.997894313 0.8747922 Mutant 1.0965763552
+#> Cell588 -1.530208288 0.8349958 WT -0.3521112892
+#> Cell1131 3.575455690 0.8661208 Mutant 0.7809150699
+#> Cell1036 4.344174164 0.8708070 Mutant 0.9515056722
+#> Cell372 -3.199534769 0.8248193 WT -0.7225608354
+#> Cell1639 3.292804748 0.8643977 Mutant 0.7181904233
+#> Cell1911 4.691621135 0.8729251 Mutant 1.0286095667
+#> Cell304 0.375560576 0.8466137 WT 0.0708085047
+#> Cell1221 6.697669433 0.8851543 Mutant 1.4737829288
+#> Cell178 -3.881346936 0.8206628 WT -0.8738655747
+#> Cell523 -7.890379642 0.7962230 WT -1.7635323741
+#> Cell877 -2.711916185 0.8277919 WT -0.6143506769
+#> Cell1871 4.390904619 0.8710919 Mutant 0.9618758879
+#> Cell1600 5.104066503 0.8754395 Mutant 1.1201376177
+#> Cell1858 5.744263723 0.8793422 Mutant 1.2622073522
+#> Cell570 -3.217921776 0.8247072 WT -0.7266411988
+#> Cell313 -4.136986857 0.8191044 WT -0.9305960549
+#> Cell628 -3.189370529 0.8248812 WT -0.7203052324
+#> Cell500 -7.090576888 0.8010988 WT -1.5860436857
+#> Cell501 -2.930850404 0.8264572 WT -0.6629355901
+#> Cell622 -3.458374349 0.8232413 WT -0.7800013698
+#> Cell777 -1.352596436 0.8360785 WT -0.3126964528
+#> Cell634 -6.896019834 0.8022848 WT -1.5428684453
+#> Cell1585 5.450907404 0.8775539 Mutant 1.1971070157
+#> Cell771 -1.004896259 0.8381982 WT -0.2355363679
+#> Cell1029 4.628309224 0.8725392 Mutant 1.0145596675
+#> Cell920 -3.197806294 0.8248298 WT -0.7221772599
+#> Cell1712 1.904389462 0.8559337 Mutant 0.4100794464
+#> Cell447 -1.107174071 0.8375747 WT -0.2582334075
+#> Cell129 -11.844061352 0.7721207 WT -2.6409159252
+#> Cell79 -2.924590923 0.8264954 WT -0.6615465137
+#> Cell1497 3.874217958 0.8679421 Mutant 0.8472150704
+#> Cell1684 3.338174956 0.8646743 Mutant 0.7282587791
+#> Cell531 -8.479709885 0.7926304 WT -1.8943139340
+#> Cell162 -2.949866410 0.8263413 WT -0.6671555379
+#> Cell1989 1.791549835 0.8552458 Mutant 0.3850385757
+#> Cell1349 4.322581676 0.8706754 Mutant 0.9467139629
+#> Cell1075 5.444444181 0.8775145 Mutant 1.1956727259
+#> Cell1060 4.870654104 0.8740165 Mutant 1.0683397709
+#> Cell1801 1.995807872 0.8564910 Mutant 0.4303666156
+#> Cell1028 5.046281051 0.8750872 Mutant 1.1073141259
+#> Cell97 7.193236757 0.8881754 WT 1.5837570366
+#> Cell161 -7.415454096 0.7991183 WT -1.6581389982
+#> Cell1892 4.172627636 0.8697612 Mutant 0.9134368258
+#> Cell1283 1.696793232 0.8546681 Mutant 0.3640106097
+#> Cell1958 4.919009370 0.8743113 Mutant 1.0790705577
+#> Cell1238 2.861059884 0.8617657 Mutant 0.6223795134
+#> Cell191 -4.651417566 0.8159683 WT -1.0447562417
+#> Cell1282 3.383313628 0.8649495 Mutant 0.7382757535
+#> Cell1389 2.483951890 0.8594668 Mutant 0.5386933760
+#> Cell1471 3.415747322 0.8651472 Mutant 0.7454732955
+#> Cell844 -19.595295852 0.7248678 WT -4.3610355884
+#> Cell1771 1.686081555 0.8546028 Mutant 0.3616335216
+#> Cell12 -5.199826918 0.8126251 WT -1.1664568186
+#> Cell827 -2.599653956 0.8284762 WT -0.5894379398
+#> Cell176 -4.648930389 0.8159835 WT -1.0442042983
+#> Cell1545 1.888876736 0.8558391 Mutant 0.4066369309
+#> Cell422 -1.683599129 0.8340607 WT -0.3861511058
+#> Cell230 -17.525291207 0.7374869 WT -3.9016693169
+#> Cell1442 5.682652133 0.8789666 Mutant 1.2485347807
+#> Cell1159 1.935234824 0.8561217 Mutant 0.4169245126
+#> Cell930 -4.950147569 0.8141472 WT -1.1110490821
+#> Cell670 -4.909241142 0.8143966 WT -1.1019713089
+#> Cell369 -2.715543867 0.8277698 WT -0.6151557160
+#> Cell1747 4.217433735 0.8700344 Mutant 0.9233799970
+#> Cell707 -3.654020953 0.8220486 WT -0.8234183985
+#> Cell1407 5.980624321 0.8807831 Mutant 1.3146594501
+#> Cell1698 1.939626556 0.8561485 Mutant 0.4178991065
+#> Cell1509 1.553196728 0.8537927 Mutant 0.3321443090
+#> Cell690 -6.075247555 0.8072884 WT -1.3607262927
+#> Cell64 -1.743308470 0.8336967 WT -0.3994015386
+#> Cell794 -4.007670999 0.8198927 WT -0.9018988519
+#> Cell1425 7.100449887 0.8876098 Mutant 1.5631661848
+#> Cell1354 6.044345785 0.8811716 Mutant 1.3288002356
+#> Cell595 -0.002082865 0.8443115 WT -0.0129964567
+#> Cell323 -1.126546176 0.8374566 WT -0.2625323792
+#> Cell1268 1.981964359 0.8564066 Mutant 0.4272945244
+#> Cell274 -5.501315857 0.8107872 WT -1.2333619098
+#> Cell558 -3.158194561 0.8250713 WT -0.7133867993
+#> Cell1292 4.396207500 0.8711242 Mutant 0.9630526799
+#> Cell1181 8.377765953 0.8953965 Mutant 1.8466225144
+#> Cell35 -5.605459893 0.8101523 WT -1.2564730936
+#> Cell477 -0.826269011 0.8392871 WT -0.1958961996
+#> Cell450 -6.828779422 0.8026947 WT -1.5279467504
+#> Cell258 -1.938741632 0.8325053 WT -0.4427712013
+#> Cell1770 3.472923321 0.8654957 Mutant 0.7581615401
+#> Cell1778 2.070509715 0.8569464 Mutant 0.4469441179
+#> Cell1689 8.364137820 0.8953134 Mutant 1.8435982196
+#> Cell1208 0.836188435 0.8494217 Mutant 0.1730290011
+#> Cell1396 3.138847852 0.8634591 Mutant 0.6840249903
+#> Cell1915 5.009858172 0.8748652 Mutant 1.0992313218
+#> Cell90 0.283896208 0.8460549 WT 0.0504667538
+#> Cell1590 6.228098815 0.8822918 Mutant 1.3695778948
+#> Cell1327 0.332768685 0.8463528 Mutant 0.0613123176
+#> Cell742 -2.084118258 0.8316190 WT -0.4750325388
+#> Cell1807 0.096054819 0.8449097 Mutant 0.0087818239
+#> Cell1378 3.167291617 0.8636325 Mutant 0.6903371046
+#> Cell1954 5.827708934 0.8798509 Mutant 1.2807251441
+#> Cell472 -2.709360668 0.8278074 WT -0.6137835680
+#> Cell1737 3.209151725 0.8638877 Mutant 0.6996265147
+#> Cell774 -9.726717519 0.7850284 WT -2.1710443504
+#> Cell1039 6.053066366 0.8812247 Mutant 1.3307354682
+#> Cell1955 4.538133273 0.8719894 Mutant 0.9945482195
+#> Cell1912 5.827572565 0.8798501 Mutant 1.2806948818
+#> Cell426 -2.136323274 0.8313008 WT -0.4866176449
+#> Cell1916 2.767592369 0.8611959 Mutant 0.6016376162
+#> Cell305 -3.229467840 0.8246368 WT -0.7292034502
+#> Cell1646 3.497326159 0.8656445 Mutant 0.7635769099
+#> Cell870 -1.415433341 0.8356955 WT -0.3266409408
+#> Cell244 -4.554700673 0.8165579 WT -1.0232932567
+#> Cell1400 4.581764369 0.8722554 Mutant 1.0042306391
+#> Cell1398 2.880267289 0.8618828 Mutant 0.6266419358
+#> Cell1037 1.628651600 0.8542527 Mutant 0.3488889202
+#> Cell976 -4.902253161 0.8144392 WT -1.1004205670
+#> Cell1942 3.309939046 0.8645021 Mutant 0.7219927911
+#> Cell159 -0.907296085 0.8387931 WT -0.2138773693
+#> Cell1511 3.600602589 0.8662741 Mutant 0.7864955584
+#> Cell69 -10.783744585 0.7785846 WT -2.4056151199
+#> Cell574 -4.716389216 0.8155722 WT -1.0591744628
+#> Cell1789 6.472558800 0.8837820 Mutant 1.4238273731
+#> Cell1167 3.331131994 0.8646313 Mutant 0.7266958363
+#> Cell388 -2.395781716 0.8297191 WT -0.5441955143
+#> Cell168 -7.060414690 0.8012827 WT -1.5793502242
+#> Cell1840 1.570116051 0.8538959 Mutant 0.3358989703
+#> Cell231 -6.066028263 0.8073446 WT -1.3586803882
+#> Cell54 0.477695642 0.8472363 WT 0.0934738666
+#> Cell625 -8.282924723 0.7938300 WT -1.8506442414
+#> Cell213 -4.133438249 0.8191260 WT -0.9298085635
+#> Cell1800 6.694701632 0.8851363 Mutant 1.4731243274
+#> Cell1657 2.334848150 0.8585578 Mutant 0.5056049339
+#> Cell309 -1.806024771 0.8333143 WT -0.4133192627
+#> Cell194 0.392584287 0.8467174 WT 0.0745863314
+#> Cell1263 3.763025960 0.8672642 Mutant 0.8225398341
+#> Cell1236 0.051478216 0.8446380 Mutant -0.0011104187
+#> Cell933 -2.774783073 0.8274086 WT -0.6283018186
+#> Cell347 -4.785454481 0.8151512 WT -1.0745011208
+#> Cell697 -5.651913343 0.8098691 WT -1.2667818376
+#> Cell1180 3.228465425 0.8640055 Mutant 0.7039125255
+#> Cell281 -6.187339699 0.8066051 WT -1.3856012854
+#> Cell459 0.348688590 0.8464498 WT 0.0648451924
+#> Cell1270 3.120614707 0.8633480 Mutant 0.6799787713
+#> Cell1529 5.561813417 0.8782300 Mutant 1.2217187875
+#> Cell1727 4.097341084 0.8693023 Mutant 0.8967295672
+#> Cell994 -9.416685199 0.7869184 WT -2.1022433498
+#> Cell1754 2.295328228 0.8583169 Mutant 0.4968348476
+#> Cell245 -2.076642445 0.8316646 WT -0.4733735393
+#> Cell399 -5.438963607 0.8111673 WT -1.2195249743
+#> Cell433 -1.985159452 0.8322223 WT -0.4530720384
+#> Cell698 -2.272651105 0.8304697 WT -0.5168709141
+#> Cell1424 3.092832770 0.8631786 Mutant 0.6738135268
+#> Cell366 -5.784738627 0.8090594 WT -1.2962578369
+#> Cell1841 3.308432022 0.8644930 Mutant 0.7216583590
+#> Cell1968 3.514428566 0.8657488 Mutant 0.7673722005
+#> Cell1526 5.918065622 0.8804017 Mutant 1.3007767004
+#> Cell312 -1.341651855 0.8361452 WT -0.3102676797
+#> Cell671 -2.980140576 0.8261567 WT -0.6738738469
+#> Cell674 -2.488876309 0.8291516 WT -0.5648546546
+#> Cell392 3.146944234 0.8635085 WT 0.6858217034
+#> Cell960 -0.666755602 0.8402595 WT -0.1604976896
+#> Cell1966 1.313419499 0.8523310 Mutant 0.2789340072
+#> Cell651 -4.463854353 0.8171117 WT -1.0031330432
+#> Cell726 -6.072287799 0.8073065 WT -1.3600694768
+#> Cell669 -8.142511210 0.7946860 WT -1.8194842961
+#> Cell384 -0.113599631 0.8436317 WT -0.0377437640
+#> Cell1796 3.494889994 0.8656296 Mutant 0.7630362871
+#> Cell389 -6.606361623 0.8040506 WT -1.4785887767
+#> Cell1804 3.630531831 0.8664565 Mutant 0.7931373233
+#> Cell5 -9.328238740 0.7874576 WT -2.0826157029
+#> Cell689 -1.154593327 0.8372856 WT -0.2687564790
+#> Cell952 -1.434508344 0.8355792 WT -0.3308739809
+#> Cell562 -0.252090924 0.8427874 WT -0.0684771391
+#> Cell1960 2.263396534 0.8581222 Mutant 0.4897487075
+#> Cell181 -10.233011078 0.7819420 WT -2.2833987767
+#> Cell509 -5.880643738 0.8084747 WT -1.3175406747
+#> Cell1539 5.923649080 0.8804358 Mutant 1.3020157567
+#> Cell943 -6.044607666 0.8074752 WT -1.3539268241
+#> Cell1930 2.855349890 0.8617309 Mutant 0.6211123770
+#> Cell1330 4.440675958 0.8713953 Mutant 0.9729209233
+#> Cell1633 2.869600964 0.8618178 Mutant 0.6242749123
+#> Cell636 -4.479971775 0.8170135 WT -1.0067097503
+#> Cell1844 4.018111892 0.8688193 Mutant 0.8791473755
+#> Cell101 -0.613585933 0.8405837 WT -0.1486985119
+#> Cell747 -9.706699153 0.7851504 WT -2.1666019632
+#> Cell1788 5.821073911 0.8798105 Mutant 1.2792527292
+#> Cell1478 4.942109471 0.8744521 Mutant 1.0841968297
+#> Cell1318 0.350438524 0.8464605 Mutant 0.0652335301
+#> Cell848 -6.573895618 0.8042486 WT -1.4713840645
+#> Cell705 -1.264259584 0.8366170 WT -0.2930931294
+#> Cell284 2.358416100 0.8587015 WT 0.5108350291
+#> Cell1118 4.381234422 0.8710330 Mutant 0.9597299207
+#> Cell1347 4.130869214 0.8695067 Mutant 0.9041699814
+#> Cell105 -3.506896538 0.8229455 WT -0.7907691993
+#> Cell155 -4.675025834 0.8158244 WT -1.0499952841
+#> Cell785 -2.007245146 0.8320877 WT -0.4579731978
+#> Cell648 -4.410303177 0.8174382 WT -0.9912492032
+#> Cell446 -0.845093290 0.8391723 WT -0.2000736002
+#> Cell1726 11.278718444 0.9130812 Mutant 2.4903890553
+#> Cell123 -1.928198543 0.8325695 WT -0.4404315254
+#> Cell866 -4.471697606 0.8170639 WT -1.0048735833
+#> Cell249 -0.857219461 0.8390984 WT -0.2027645865
+#> Cell1339 3.911760046 0.8681710 Mutant 0.8555462444
+#> Cell921 -3.007083235 0.8259925 WT -0.6798528426
+#> Cell519 -0.578933150 0.8407949 WT -0.1410085196
+#> Cell797 0.653976559 0.8483109 WT 0.1325933478
+#> Cell1552 1.916419391 0.8560070 Mutant 0.4127490752
+#> Cell772 -3.498057273 0.8229994 WT -0.7888076288
+#> Cell732 -6.250358776 0.8062209 WT -1.3995862000
+#> Cell515 0.301787370 0.8461639 WT 0.0544370812
+#> Cell992 -7.071853639 0.8012129 WT -1.5818887052
+#> Cell337 -6.138042984 0.8069056 WT -1.3746615766
+#> Cell86 -0.235834202 0.8428865 WT -0.0648695192
+#> Cell869 -5.734908814 0.8093632 WT -1.2851998251
+#> Cell748 -4.278770866 0.8182400 WT -0.9620601348
+#> Cell864 -0.610364260 0.8406033 WT -0.1479835725
+#> Cell1577 1.565861587 0.8538699 Mutant 0.3349548383
+#> Cell404 -4.687260098 0.8157498 WT -1.0527102577
+#> Cell538 -4.484420941 0.8169864 WT -1.0076970895
+#> Cell945 -1.874991598 0.8328939 WT -0.4286240757
+#> Cell197 -5.139934275 0.8129902 WT -1.1531657081
+#> Cell34 -2.016121287 0.8320336 WT -0.4599429518
+#> Cell845 -5.302508710 0.8119992 WT -1.1892435074
+#> Cell1335 2.238092739 0.8579680 Mutant 0.4841334012
+#> Cell1437 4.697112439 0.8729586 Mutant 1.0298281725
+#> Cell1296 3.300300561 0.8644434 Mutant 0.7198538610
+#> Cell158 -2.011055374 0.8320644 WT -0.4588187468
+#> Cell759 -4.836694538 0.8148388 WT -1.0858720874
+#> Cell831 0.512309634 0.8474473 WT 0.1011552507
+#> Cell1468 3.555120804 0.8659968 Mutant 0.7764024418
+#> Cell339 -4.157260920 0.8189808 WT -0.9350951852
+#> Cell561 -5.958783807 0.8079984 WT -1.3348811730
+#> Cell121 -5.873042940 0.8085211 WT -1.3158539393
+#> Cell1826 3.305104394 0.8644727 Mutant 0.7209199065
+#> Cell1344 2.517353860 0.8596704 Mutant 0.5461057934
+#> Cell1674 2.133559587 0.8573307 Mutant 0.4609358665
+#> Cell225 -2.907183774 0.8266015 WT -0.6576835962
+#> Cell1793 1.916956072 0.8560103 Mutant 0.4128681729
+#> Cell1837 4.501838485 0.8717682 Mutant 0.9864938406
+#> Cell534 -2.841560517 0.8270015 WT -0.6431207733
+#> Cell401 -15.973009309 0.7469499 WT -3.5571937863
+#> Cell10 -2.457010617 0.8293458 WT -0.5577831612
+#> Cell1584 3.302191137 0.8644549 Mutant 0.7202734093
+#> Cell179 0.959640189 0.8501743 WT 0.2004248680
+#> Cell503 -1.910114193 0.8326798 WT -0.4364183265
+#> Cell1087 2.476127802 0.8594191 Mutant 0.5369570892
+#> Cell751 -3.933876538 0.8203426 WT -0.8855227117
+#> Cell1792 3.923161454 0.8682405 Mutant 0.8580763944
+#> Cell1248 5.915112493 0.8803837 Mutant 1.3001213552
+#> Cell1146 1.165036165 0.8514264 Mutant 0.2460054342
+#> Cell1076 2.289754464 0.8582829 Mutant 0.4955979427
+#> Cell378 -0.434472771 0.8416756 WT -0.1089505115
+#> Cell757 -9.442341995 0.7867620 WT -2.1079369923
+#> Cell805 5.533783697 0.8780591 WT 1.2154985560
+#> Cell1614 2.392536987 0.8589095 Mutant 0.5184069852
+#> Cell838 -12.016536703 0.7710693 WT -2.6791908919
+#> Cell1670 0.857919638 0.8495542 Mutant 0.1778514934
+#> Cell1113 6.667042558 0.8849676 Mutant 1.4669863481
+#> Cell718 2.008210082 0.8565666 WT 0.4331188591
+#> Cell1630 3.222509774 0.8639692 Mutant 0.7025908739
+#> Cell640 0.287690332 0.8460780 WT 0.0513087290
+#> Cell496 -7.002914099 0.8016332 WT -1.5665899476
+#> Cell1331 4.031490958 0.8689009 Mutant 0.8821163986
+#> Cell1547 3.497787304 0.8656473 Mutant 0.7636792451
+#> Cell1847 6.175221217 0.8819694 Mutant 1.3578435323
+#> Cell1865 2.759220547 0.8611449 Mutant 0.5997797785
+#> Cell439 -0.981485161 0.8383409 WT -0.2303410808
+#> Cell1495 3.037720740 0.8628427 Mutant 0.6615833089
+#> Cell820 -6.764885772 0.8030843 WT -1.5137677545
+#> Cell1078 5.815488593 0.8797764 Mutant 1.2780132600
+#> Cell1166 2.632684939 0.8603735 Mutant 0.5716995563
+#> Cell1138 -0.413339024 0.8418044 Mutant -0.1042606038
+#> Cell1199 0.485094313 0.8472814 Mutant 0.0951157470
+#> Cell1898 8.128245380 0.8938754 Mutant 1.7912500130
+#> Cell55 -0.249797289 0.8428014 WT -0.0679681456
+#> Cell1412 4.684050355 0.8728790 Mutant 1.0269294927
+#> Cell81 -4.347717448 0.8178197 WT -0.9773604553
+#> Cell1797 3.839513969 0.8677305 Mutant 0.8395137147
+#> Cell267 -1.569615474 0.8347555 WT -0.3608563574
+#> Cell1709 7.858539682 0.8922312 Mutant 1.7313981179
+#> Cell1563 3.111449771 0.8632921 Mutant 0.6779449294
+#> Cell1017 3.014114350 0.8626988 Mutant 0.6563446833
+#> Cell238 -7.829027394 0.7965971 WT -1.7499173547
+#> Cell802 -1.272071136 0.8365694 WT -0.2948266345
+#> Cell286 5.631363589 0.8786540 WT 1.2371530539
+#> Cell1842 4.937514514 0.8744241 Mutant 1.0831771373
+#> Cell1351 3.262225940 0.8642113 Mutant 0.7114045097
+#> Cell202 -4.655745848 0.8159419 WT -1.0457167548
+#> Cell119 -4.197567149 0.8187351 WT -0.9440397653
+#> Cell1366 2.958401708 0.8623591 Mutant 0.6439811805
+#> Cell825 0.771298130 0.8490262 WT 0.1586288316
+#> Cell1854 5.331843552 0.8768280 Mutant 1.1706848926
+#> Cell1420 1.160349437 0.8513979 Mutant 0.2449653762
+#> Cell257 -6.367491264 0.8055068 WT -1.4255797234
+#> Cell1593 4.981783664 0.8746940 Mutant 1.0930011512
+#> Cell1232 2.557334742 0.8599141 Mutant 0.5549781739
+#> Cell985 1.443609047 0.8531247 WT 0.3078250955
+#> Cell204 -4.073165032 0.8194935 WT -0.9164329979
+#> Cell1357 3.756377057 0.8672237 Mutant 0.8210643391
+#> Cell1481 2.346220208 0.8586272 Mutant 0.5081285706
+#> Cell1592 2.091353672 0.8570734 Mutant 0.4515697167
+#> Cell1618 4.846298215 0.8738681 Mutant 1.0629348197
+#> Cell1549 3.694010834 0.8668435 Mutant 0.8072243028
+#> Cell514 -1.222313732 0.8368727 WT -0.2837846915
+#> Cell734 -4.230782413 0.8185326 WT -0.9514107496
+#> Cell1053 4.239386963 0.8701682 Mutant 0.9282517601
+#> Cell1768 5.093900304 0.8753775 Mutant 1.1178815799
+#> Cell1184 5.873788282 0.8801318 Mutant 1.2909508691
+#> Cell699 -6.860772268 0.8024997 WT -1.5350464613
+#> Cell573 -2.998000817 0.8260478 WT -0.6778373126
+#> Cell978 -0.825042535 0.8392946 WT -0.1956240254
+#> Cell1015 2.838582416 0.8616287 Mutant 0.6173914132
+#> Cell92 -2.264823163 0.8305174 WT -0.5151337717
+#> Cell821 -4.883402919 0.8145541 WT -1.0962374047
+#> Cell1241 2.638256338 0.8604075 Mutant 0.5729359364
+#> Cell1609 4.262184280 0.8703072 Mutant 0.9333108398
+#> Cell663 -3.892971273 0.8205919 WT -0.8764451962
+#> Cell1088 7.047852539 0.8872891 Mutant 1.5514940142
+#> Cell1973 4.555069329 0.8720927 Mutant 0.9983065939
+#> Cell1690 4.916967811 0.8742989 Mutant 1.0786175038
+#> Cell1685 2.508357170 0.8596156 Mutant 0.5441092878
+#> Cell38 -4.802609816 0.8150466 WT -1.0783081567
+#> Cell1702 2.685913957 0.8606980 Mutant 0.5835119045
+#> Cell1038 3.944102297 0.8683681 Mutant 0.8627234937
+#> Cell405 -3.118423743 0.8253137 WT -0.7045610355
+#> Cell1104 4.255657939 0.8702674 Mutant 0.9318625433
+#> Cell276 -1.879459448 0.8328667 WT -0.4296155612
+#> Cell502 2.357720885 0.8586973 WT 0.5106807501
+#> Cell1306 1.498045396 0.8534565 Mutant 0.3199053693
+#> Cell730 -6.648068340 0.8037964 WT -1.4878441467
+#> Cell1179 0.542483744 0.8476313 Mutant 0.1078513555
+#> Cell1483 3.296510953 0.8644203 Mutant 0.7190128880
+#> Cell1818 4.941171184 0.8744464 Mutant 1.0839886093
+#> Cell1156 2.282823330 0.8582407 Mutant 0.4940598160
+#> Cell1634 3.256197475 0.8641745 Mutant 0.7100666993
+#> Cell1399 -1.224704043 0.8368582 Mutant -0.2843151389
+#> Cell174 -3.911275428 0.8204804 WT -0.8805071732
+#> Cell655 -0.105159505 0.8436831 WT -0.0358707686
+#> Cell1528 3.219727649 0.8639522 Mutant 0.7019734770
+#> Cell1561 3.923816362 0.8682445 Mutant 0.8582217288
+#> Cell719 -6.068007098 0.8073325 WT -1.3591195225
+#> Cell616 -1.966781678 0.8323343 WT -0.4489937242
+#> Cell1628 4.043549181 0.8689744 Mutant 0.8847923060
+#> Cell596 -0.434203241 0.8416772 WT -0.1088906987
+#> Cell850 -5.714969234 0.8094847 WT -1.2807749219
+#> Cell632 -3.043692806 0.8257693 WT -0.6879770767
+#> Cell215 -4.442662286 0.8172409 WT -0.9984301936
+#> Cell1814 5.328387744 0.8768070 Mutant 1.1699179951
+#> Cell71 -1.661453976 0.8341957 WT -0.3812367514
+#> Cell44 -9.462636505 0.7866383 WT -2.1124406602
+#> Cell600 -0.657884472 0.8403136 WT -0.1585290477
+#> Cell1249 2.122742589 0.8572648 Mutant 0.4585354063
+#> Cell185 -3.840412020 0.8209124 WT -0.8647814792
+#> Cell1463 5.337363616 0.8768617 Mutant 1.1719098808
+#> Cell150 -6.804774843 0.8028411 WT -1.5226197606
+#> Cell1856 4.937359112 0.8744232 Mutant 1.0831426513
+#> Cell1928 2.186462900 0.8576532 Mutant 0.4726759357
+#> Cell1723 3.806163697 0.8675272 Mutant 0.8321127699
+#> Cell788 -4.225321038 0.8185659 WT -0.9501987856
+#> Cell1649 3.548653523 0.8659574 Mutant 0.7749672514
+#> Cell182 -2.299215831 0.8303078 WT -0.5227660404
+#> Cell186 -3.682899415 0.8218726 WT -0.8298269789
+#> Cell1175 3.283676794 0.8643420 Mutant 0.7161647882
+#> Cell535 -0.368924616 0.8420752 WT -0.0944043549
+#> Cell630 -4.594423424 0.8163158 WT -1.0321083539
+#> Cell1082 2.156868601 0.8574728 Mutant 0.4661084997
+#> Cell237 -3.690336667 0.8218272 WT -0.8314774211
+#> Cell1503 4.310370328 0.8706010 Mutant 0.9440040744
+#> Cell443 -0.324802234 0.8423441 WT -0.0846129111
+#> Cell857 -3.880601023 0.8206674 WT -0.8737000451
+#> Cell1376 3.932055418 0.8682947 Mutant 0.8600501036
+#> Cell318 -3.061130343 0.8256630 WT -0.6918467377
+#> Cell510 0.765787924 0.8489926 WT 0.1574060311
+#> Cell1575 5.870996927 0.8801148 Mutant 1.2903314240
+#> Cell8 -0.304597995 0.8424673 WT -0.0801292760
+#> Cell1050 3.437409677 0.8652792 Mutant 0.7502805094
+#> Cell70 -7.522571206 0.7984653 WT -1.6819099534
+#> Cell1191 6.697020780 0.8851504 Mutant 1.4736389826
+#> Cell1365 1.299194555 0.8522443 Mutant 0.2757772704
+#> Cell1535 2.602376773 0.8601887 Mutant 0.5649737020
+#> Cell338 -15.146998782 0.7519854 WT -3.3738891850
+#> Cell1474 5.709286335 0.8791290 Mutant 1.2544453249
+#> Cell929 -0.096022094 0.8437388 WT -0.0338430349
+#> Cell1957 5.910271530 0.8803542 Mutant 1.2990470701
+#> Cell657 -5.234651627 0.8124128 WT -1.1741849637
+#> Cell1041 5.848269129 0.8799763 Mutant 1.2852877715
+#> Cell1032 3.445563166 0.8653289 Mutant 0.7520898956
+#> Cell200 -3.487177239 0.8230657 WT -0.7863931796
+#> Cell912 -0.548781531 0.8409787 WT -0.1343174057
+#> Cell253 -3.692693653 0.8218129 WT -0.8320004728
+#> Cell461 -4.353326438 0.8177855 WT -0.9786051774
+#> Cell1434 2.771523319 0.8612199 Mutant 0.6025099552
+#> Cell247 -1.183339152 0.8371103 WT -0.2751356252
+#> Cell147 -7.986962962 0.7956343 WT -1.7849657170
+#> Cell412 -1.876144378 0.8328869 WT -0.4288798955
+#> Cell216 -3.843652752 0.8208926 WT -0.8655006482
+#> Cell687 -7.574808814 0.7981468 WT -1.6935022922
+#> Cell592 -5.602448440 0.8101707 WT -1.2558048050
+#> Cell172 -0.700530565 0.8400536 WT -0.1679928800
+#> Cell1713 2.800926897 0.8613991 Mutant 0.6090350670
+#> Cell84 -3.900975245 0.8205432 WT -0.8782214023
+#> Cell728 -0.946714024 0.8385528 WT -0.2226248237
+#> Cell1361 3.992385055 0.8686625 Mutant 0.8734381896
+#> Cell1556 2.952236597 0.8623215 Mutant 0.6426130462
+#> Cell1423 3.268933216 0.8642522 Mutant 0.7128929586
+#> Cell7 -4.512267255 0.8168166 WT -1.0138766204
+#> Cell352 -6.976907391 0.8017917 WT -1.5608186539
+#> Cell1301 2.082096703 0.8570170 Mutant 0.4495154510
+#> Cell248 -2.039951089 0.8318883 WT -0.4652311561
+#> Cell783 -2.020710565 0.8320056 WT -0.4609613841
+#> Cell356 -0.647599640 0.8403763 WT -0.1562466832
+#> Cell549 0.191741079 0.8454931 WT 0.0300160953
+#> Cell1 -0.107054702 0.8436716 WT -0.0362913423
+#> Cell1086 2.239439761 0.8579762 Mutant 0.4844323263
+#> Cell1982 0.904694276 0.8498394 Mutant 0.1882315142
+#> Cell27 -4.733010792 0.8154709 WT -1.0628630494
+#> Cell146 0.386096149 0.8466779 WT 0.0731465125
+#> Cell329 -3.813459634 0.8210767 WT -0.8588003250
+#> Cell1355 4.091853076 0.8692688 Mutant 0.8955116927
+#> Cell1877 3.841473281 0.8677425 Mutant 0.8399485165
+#> Cell130 -8.159772525 0.7945808 WT -1.8233148506
+#> Cell299 -11.211894351 0.7759745 WT -2.5006282214
+#> Cell80 -2.002774724 0.8321149 WT -0.4569811416
+#> Cell852 -1.841001384 0.8331011 WT -0.4210811178
+#> Cell1564 2.278426288 0.8582139 Mutant 0.4930840439
+#> Cell525 -2.090867429 0.8315779 WT -0.4765302848
+#> Cell907 -3.957329759 0.8201996 WT -0.8907273466
+#> Cell140 -3.687203097 0.8218463 WT -0.8307820330
+#> Cell1204 2.628264823 0.8603465 Mutant 0.5707186636
+#> Cell141 -2.163523772 0.8311350 WT -0.4926538591
+#> Cell153 -3.890934343 0.8206044 WT -0.8759931696
+#> Cell1012 2.441325816 0.8592069 Mutant 0.5292339864
+#> Cell287 1.351415210 0.8525626 WT 0.2873658471
+#> Cell67 -6.091039863 0.8071921 WT -1.3642308519
+#> Cell1779 11.205401994 0.9126343 Mutant 2.4741189933
+#> Cell2000 4.809645318 0.8736446 Mutant 1.0548009711
+#> Cell1739 2.102815098 0.8571433 Mutant 0.4541131857
+#> Cell212 -3.941065303 0.8202988 WT -0.8871180106
+#> Cell981 1.105003320 0.8510605 WT 0.2326832109
+#> Cell955 -3.931901011 0.8203546 WT -0.8850843113
+#> Cell1774 4.899100023 0.8741900 Mutant 1.0746523634
+#> Cell1276 2.864828802 0.8617887 Mutant 0.6232158951
+#> Cell741 -3.659584090 0.8220147 WT -0.8246529453
+#> Cell1151 3.697735589 0.8668662 Mutant 0.8080508839
+#> Cell1508 5.196014403 0.8760000 Mutant 1.1405422888
+#> Cell1967 5.426419751 0.8774046 Mutant 1.1916728243
+#> Cell1798 3.854174338 0.8678199 Mutant 0.8427670789
+#> Cell743 -4.132134921 0.8191340 WT -0.9295193347
+#> Cell269 -3.404979663 0.8235668 WT -0.7681522572
+#> Cell766 -0.511977715 0.8412031 WT -0.1261500657
+#> Cell1368 4.464678767 0.8715416 Mutant 0.9782475204
+#> Cell280 -2.240158256 0.8306678 WT -0.5096602446
+#> Cell1533 2.335499603 0.8585618 Mutant 0.5057495015
+#> Cell1959 5.046188530 0.8750866 Mutant 1.1072935942
+#> Cell721 -1.009087588 0.8381726 WT -0.2364664892
+#> Cell438 0.480742983 0.8472549 WT 0.0941501192
+#> Cell414 -8.182011529 0.7944452 WT -1.8282500321
+#> Cell1742 3.337452450 0.8646699 Mutant 0.7280984439
+#> Cell1895 6.660880586 0.8849301 Mutant 1.4656189107
+#> Cell715 -4.774182621 0.8152199 WT -1.0719997194
+#> Cell964 -4.188391126 0.8187910 WT -0.9420034628
+#> Cell1937 2.620327334 0.8602982 Mutant 0.5689572113
+#> Cell1909 3.797071720 0.8674718 Mutant 0.8300951186
+#> Cell436 -1.509922807 0.8351194 WT -0.3476096250
+#> Cell205 -7.265008462 0.8000354 WT -1.6247527689
+#> Cell1929 -0.042900280 0.8440627 Mutant -0.0220544769
+#> Cell96 -5.454876388 0.8110703 WT -1.2230562684
+#> Cell1097 4.557561353 0.8721079 Mutant 0.9988596129
+#> Cell1952 1.344951377 0.8525232 Mutant 0.2859314220
+#> Cell796 -6.795746005 0.8028961 WT -1.5206161207
+#> Cell1812 2.598353345 0.8601642 Mutant 0.5640808409
+#> Cell1489 3.370765004 0.8648730 Mutant 0.7354910184
+#> Cell731 -11.866909026 0.7719814 WT -2.6459861799
+#> Cell1477 1.993907370 0.8564794 Mutant 0.4299448645
+#> Cell246 -1.865185610 0.8329537 WT -0.4264479742
+#> Cell330 -6.317147993 0.8058137 WT -1.4144077677
+#> Cell290 -6.467835888 0.8048951 WT -1.4478477585
+#> Cell319 -2.812208055 0.8271805 WT -0.6366070049
+#> Cell1594 3.303990834 0.8644659 Mutant 0.7206727900
+#> Cell1066 3.789751421 0.8674272 Mutant 0.8284706302
+#> Cell1565 4.140733883 0.8695668 Mutant 0.9063591051
+#> Cell321 -5.952137758 0.8080389 WT -1.3334063113
+#> Cell1310 4.007849362 0.8687567 Mutant 0.8768699603
+#> Cell1857 3.677443408 0.8667425 Mutant 0.8035477328
+#> Cell1466 1.497820629 0.8534552 Mutant 0.3198554900
+#> Cell1290 7.713513930 0.8913471 Mutant 1.6992146446
+#> Cell891 -9.507693092 0.7863636 WT -2.1224394187
+#> Cell1439 0.888140462 0.8497384 Mutant 0.1845579649
+#> Cell904 -8.792506443 0.7907235 WT -1.9637283621
+#> Cell368 1.999551465 0.8565138 WT 0.4311973771
+#> Cell406 -5.014502823 0.8137549 WT -1.1253305152
+#> Cell1340 3.891763634 0.8680491 Mutant 0.8511087292
+#> Cell1150 13.801782678 0.9284623 Mutant 3.0502963064
+#> Cell896 -0.638106593 0.8404342 WT -0.1541400283
+#> Cell923 -4.207263189 0.8186760 WT -0.9461914675
+#> Cell1864 5.315059251 0.8767257 Mutant 1.1669601948
+#> Cell586 -6.309901734 0.8058579 WT -1.4127997098
+#> Cell1707 0.074636562 0.8447792 Mutant 0.0040287791
+#> Cell491 -2.693671957 0.8279031 WT -0.6103019986
+#> Cell195 -7.220082577 0.8003093 WT -1.6147830151
+#> Cell298 -3.485522881 0.8230758 WT -0.7860260518
+#> Cell435 -4.820986517 0.8149346 WT -1.0823862328
+#> Cell544 -2.414924239 0.8296024 WT -0.5484435382
+#> Cell219 -6.825234587 0.8027164 WT -1.5271600965
+#> Cell1637 4.470324918 0.8715761 Mutant 0.9795004893
+#> Cell1644 4.927562871 0.8743635 Mutant 1.0809687127
+#> Cell512 -8.234125005 0.7941275 WT -1.8398148240
+#> Cell1799 3.653702774 0.8665978 Mutant 0.7982793166
+#> Cell1202 1.969328716 0.8563296 Mutant 0.4244904783
+#> Cell1664 4.272083815 0.8703676 Mutant 0.9355077009
+#> Cell1636 0.047189952 0.8446119 Mutant -0.0020620512
+#> Cell1062 7.118596954 0.8877204 Mutant 1.5671933016
+#> Cell1934 2.884439163 0.8619082 Mutant 0.6275677396
+#> Cell895 -6.013831173 0.8076628 WT -1.3470970410
+#> Cell1269 -0.180215718 0.8432256 Mutant -0.0525269113
+#> Cell1893 2.043078344 0.8567791 Mutant 0.4408566695
+#> Cell493 -2.003233683 0.8321121 WT -0.4570829918
+#> Cell1005 5.166262202 0.8758186 Mutant 1.1339398120
+#> Cell1030 7.450965445 0.8897466 Mutant 1.6409510466
+#> Cell402 -8.028658424 0.7953801 WT -1.7942185896
+#> Cell1543 4.527435653 0.8719242 Mutant 0.9921742510
+#> Cell1708 2.704543243 0.8608116 Mutant 0.5876460330
+#> Cell271 -2.534469428 0.8288736 WT -0.5749724776
+#> Cell1962 1.972807331 0.8563508 Mutant 0.4252624373
+#> Cell250 -4.339542254 0.8178696 WT -0.9755462522
+#> Cell934 -4.184356103 0.8188156 WT -0.9411080283
+#> Cell170 -7.342755192 0.7995615 WT -1.6420059792
+#> Cell285 -4.128973476 0.8191532 WT -0.9288177608
+#> Cell594 -2.657656854 0.8281226 WT -0.6023096863
+#> Cell387 -7.790524417 0.7968318 WT -1.7413729444
+#> Cell108 -8.473636598 0.7926674 WT -1.8929661770
+#> Cell1550 5.102070733 0.8754273 Mutant 1.1196947254
+#> Cell1127 3.357788690 0.8647938 Mutant 0.7326113723
+#> Cell564 -5.331258960 0.8118239 WT -1.1956236356
+#> Cell1570 4.885413078 0.8741065 Mutant 1.0716150172
+#> Cell1514 5.461089402 0.8776159 Mutant 1.1993665599
+#> Cell343 -2.900191558 0.8266441 WT -0.6561319146
+#> Cell942 0.436128551 0.8469829 WT 0.0842494817
+#> Cell1947 2.093310352 0.8570854 Mutant 0.4520039345
+#> Cell1721 6.592623540 0.8845140 Mutant 1.4504716090
+#> Cell1317 6.142486147 0.8817699 Mutant 1.3505791104
+#> Cell1102 4.412786733 0.8712253 Mutant 0.9667318699
+#> Cell1210 1.988900748 0.8564489 Mutant 0.4288338171
+#> Cell166 -5.634598522 0.8099747 WT -1.2629394090
+#> Cell1433 3.873284033 0.8679364 Mutant 0.8470078179
+#> Cell1616 7.444284058 0.8897058 Mutant 1.6394683428
+#> Cell308 0.587252314 0.8479042 WT 0.1177861985
+#> Cell786 0.411824937 0.8468347 WT 0.0788561312
+#> Cell633 -1.760604197 0.8335912 WT -0.4032397298
+#> Cell1610 4.734750792 0.8731881 Mutant 1.0381807092
+#> Cell1846 2.936437911 0.8622252 Mutant 0.6391070718
+#> Cell1748 4.196021005 0.8699039 Mutant 0.9186281787
+#> Cell1787 3.088023745 0.8631493 Mutant 0.6727463293
+#> Cell1090 2.802675210 0.8614098 Mutant 0.6094230449
+#> Cell946 -0.069055666 0.8439032 WT -0.0278587645
+#> Cell675 -2.847705918 0.8269641 WT -0.6444845337
+#> Cell1040 4.634879733 0.8725792 Mutant 1.0160177659
+#> Cell1457 3.443685315 0.8653175 Mutant 0.7516731712
+#> Cell1750 5.260675022 0.8763942 Mutant 1.1548914873
+#> Cell1035 3.441518042 0.8653043 Mutant 0.7511922196
+#> Cell1410 2.791399923 0.8613410 Mutant 0.6069208832
+#> Cell189 -2.193527953 0.8309521 WT -0.4993122542
+#> Cell1352 2.551763488 0.8598802 Mutant 0.5537418258
+#> Cell233 -5.731860493 0.8093818 WT -1.2845233552
+#> Cell1132 5.564067008 0.8782437 Mutant 1.2222188945
+#> Cell83 -4.606530880 0.8162420 WT -1.0347951869
+#> Cell1245 2.669523844 0.8605981 Mutant 0.5798746830
+#> Cell118 -4.142007167 0.8190738 WT -0.9317101399
+#> Cell1896 5.243042440 0.8762867 Mutant 1.1509785427
+#> Cell1227 2.922139709 0.8621381 Mutant 0.6359340781
+#> Cell363 -2.497783954 0.8290973 WT -0.5668313997
+#> Cell441 -1.330214336 0.8362150 WT -0.3077295163
+#> Cell1943 6.527309502 0.8841158 Mutant 1.4359774066
+#> Cell556 -5.257318024 0.8122747 WT -1.1792149904
+#> Cell1224 2.684644622 0.8606902 Mutant 0.5832302192
+#> Cell610 -8.742003279 0.7910314 WT -1.9525209233
+#> Cell1772 4.911765113 0.8742672 Mutant 1.0774629441
+#> Cell1257 3.655495292 0.8666087 Mutant 0.7986771041
+#> Cell131 1.775726163 0.8551493 WT 0.3815270565
+#> Cell1083 3.119370789 0.8633404 Mutant 0.6797027265
+#> Cell1843 4.714858893 0.8730668 Mutant 1.0337663871
+#> Cell727 -5.776191894 0.8091115 WT -1.2943611837
+#> Cell1336 1.946799090 0.8561922 Mutant 0.4194908034
+#> Cell637 -1.180422928 0.8371281 WT -0.2744884696
+#> Cell631 -8.340915786 0.7934765 WT -1.8635133615
+#> Cell1220 4.250463399 0.8702358 Mutant 0.9307097938
+#> Cell1583 5.480167994 0.8777322 Mutant 1.2036003965
+#> Cell1065 3.442988386 0.8653132 Mutant 0.7515185118
+#> Cell120 -0.416530275 0.8417849 WT -0.1049687922
+#> Cell603 0.662037856 0.8483601 WT 0.1343822752
+#> Cell325 -1.676620159 0.8341032 WT -0.3846023637
+#> Cell1415 5.669698521 0.8788877 Mutant 1.2456601725
+#> Cell1988 5.251090385 0.8763357 Mutant 1.1527645071
+#> Cell1256 4.848306950 0.8738803 Mutant 1.0633805894
+#> Cell1091 2.801564190 0.8614030 Mutant 0.6091764924
+#> Cell1677 2.107118726 0.8571695 Mutant 0.4550682276
+#> Cell1541 4.470636583 0.8715780 Mutant 0.9795696526
+#> Cell608 -3.181663465 0.8249282 WT -0.7185949147
+#> Cell1293 2.612561519 0.8602508 Mutant 0.5672338559
+#> Cell409 -2.757316002 0.8275151 WT -0.6244256034
+#> Cell1995 0.408265379 0.8468130 Mutant 0.0780662100
+#> Cell548 -2.900026560 0.8266451 WT -0.6560952989
+#> Cell824 -0.683106243 0.8401598 WT -0.1641261515
+#> Cell863 -4.569219152 0.8164694 WT -1.0265151332
+#> Cell1505 3.408884325 0.8651053 Mutant 0.7439502896
+#> Cell1515 7.026530867 0.8871591 Mutant 1.5467624031
+#> Cell571 -3.834966797 0.8209456 WT -0.8635730995
+#> Cell75 -2.210378067 0.8308493 WT -0.5030515568
+#> Cell832 -10.928986512 0.7776992 WT -2.4378465657
+#> Cell585 0.605540123 0.8480157 WT 0.1218445482
+#> Cell467 -5.588367502 0.8102565 WT -1.2526800256
+#> Cell1751 3.052341956 0.8629318 Mutant 0.6648279847
+#> Cell410 0.517561592 0.8474793 WT 0.1023207419
+#> Cell1168 3.653922146 0.8665991 Mutant 0.7983279986
+#> Cell1922 2.890512331 0.8619453 Mutant 0.6289154702
+#> Cell444 -5.354371560 0.8116830 WT -1.2007526816
+#> Cell701 1.541114535 0.8537191 WT 0.3294630821
+#> Cell1935 3.575983681 0.8661240 Mutant 0.7810322393
+#> Cell46 -0.226588314 0.8429429 WT -0.0628177126
+#> Cell539 -6.001406475 0.8077386 WT -1.3443398069
+#> Cell1356 1.356056344 0.8525909 Mutant 0.2883957872
+fake_final_mds.RdA dataset generated by ComputeCellData applied to fake_test_object.
+Contains cell status and normalized values.
data(fake_final_mds)A data frame with the following columns:
A numerical value presenting the status of the cell
Numerical value representing normalized data
fake_test_object.RdA simulated Seurat object with fake gene expression data for the Wnt signaling pathway. +This Seurat object contains gene expression data from simulated cells with Wnt positive +and negative gene expression values.
+data(fake_test_object)A Seurat object. The object contains:
List of assays used for data storage. Includes RNA expression data.
Metadata associated with the cells. Contains information about the groups (e.g., WT vs. Mutant).
Gene features (including Wnt pathway genes) used in the analysis.
Cell names, labeled as Cell1, Cell2, ..., CellN.
Simulated for demonstration purposes.
+fake_to_plot.RdA dataset generated by running PreparePlotData on fake_test_object and fake_final_mds.
+Contains processed data ready for visualization, with the following features:
data(fake_to_plot)A data frame with the following columns:
A numerical or categorical value depending on the specific analysis
Normalized numerical value representing the cell's data
Group classification of the cell (e.g., "WT", "Mutant")
Scaled data for visualization purposes
data(fake_to_plot)
+head(fake_to_plot)
+#> V1 normalized genotype scale
+#> Cell819 -1.3616977 0.8360230 WT -0.31471616
+#> Cell124 -4.8660336 0.8146600 WT -1.09238288
+#> Cell1363 3.2841257 0.8643448 Mutant 0.71626440
+#> Cell1460 0.1235202 0.8450772 Mutant 0.01487683
+#> Cell117 -1.4956377 0.8352065 WT -0.34443955
+#> Cell1294 1.1383404 0.8512637 Mutant 0.24008124
+
+ All functions+ + |
+ |
|---|---|
| + + | +CalculatePercentage |
+
| + + | +ComputeCellData |
+
| + + | +LoadPathway |
+
| + + | +PathwayMaxMin |
+
| + + | +PlotPathway |
+
| + + | +A function to prepare the signal transduction dataframe for plotting |
+
| + + | +Example Cell Status and Normalized Data |
+
| + + | +Example Seurat Object for Testing |
+
| + + | +Example Processed Data for Plotting |
+