{ "cells": [ { "cell_type": "code", "execution_count": 1, "id": "57b98bc0", "metadata": {}, "outputs": [], "source": [ "#' Evaluating Gene Function Prediction\n", "#'\n", "#' The function performs gene function prediction based on 'guilt by association' \n", "#' using cross validation ([1]). Performance and significance are evaluated by \n", "#' calculating the AUROC or AUPRC of each functional group.\n", "#' \n", "#' @param genes.labels numeric array\n", "#' @param network numeric array symmetric, gene-by-gene matrix \n", "#' @param nFold numeric value, default is 3\n", "#' @param output string, default is AUROC \n", "#' @param FLAG_DRAW binary flag to draw roc plot\n", "#'\n", "#' @return scores numeric matrix with a row for each gene label and columns\n", "#' auc: the average area under the ROC or PR curve for the neighbor voting predictor\n", "#' across cross validation replicates\n", "#' avg_node_degree: the average node degree\n", "#' degree_null_auc: the area the ROC or PR curve for the node degree predictor\n", "#' \n", "#' @keywords neighbor voting \n", "#' guilt by association \n", "#' gene function prediction evaluation \n", "#' cross validation\n", "#'\n", "#' @examples \n", "#' genes.labels <- matrix( sample( c(0,1), 1000, replace=TRUE), nrow=100)\n", "#' rownames(genes.labels) = paste('gene', 1:100, sep='')\n", "#' colnames(genes.labels) = paste('function', 1:10, sep='')\n", "#' net <- cor( matrix( rnorm(10000), ncol=100), method='spearman')\n", "#' rownames(net) <- paste('gene', 1:100, sep='')\n", "#' colnames(net) <- paste('gene', 1:100, sep='')\n", "#' \n", "#' aurocs <- neighbor_voting(genes.labels, net, output = 'AUROC') \n", "#' \n", "#' avgprcs <- neighbor_voting(genes.labels, net, output = 'PR') \n", "#' \n", "#' @export\n", "#'\n", "#' \n", "neighbor_voting <- function(genes.labels, network, nFold = 3, output = \"AUROC\", FLAG_DRAW = FALSE) {\n", "\n", " genes.labels <- as.matrix(genes.labels);\n", " # Filter for common genes between network and labels\n", " #ord <- order(rownames(network));\n", " #network <- network[ord, ord];\n", " #ord <- order(rownames(genes.labels));\n", " #genes.labels <- as.matrix(genes.labels[ord, ]);\n", "\n", "\n", " maskNet <- rownames(network) %in% rownames(genes.labels)\n", " network <- network[maskNet,maskNet]\n", "\n", " maskLab <- match(rownames(network),rownames(genes.labels))\n", " genes.labels <- as.matrix(genes.labels[maskLab, ]);\n", " #match.lab <- match(rownames(genes.labels), rownames(network));\n", " #filt.lab <- !is.na(match.lab);\n", " #filt.net <- match.lab[filt.lab];\n", "\n", " #network <- network[filt.net, filt.net]\n", "\n", " #genes.labels <- as.matrix(genes.labels[filt.lab, ]);\n", " # genes.label : needs to be in 1s and 0s\n", " l <- dim(genes.labels)[2];\n", " g <- dim(genes.labels)[1];\n", " ab <- which(genes.labels != 0, arr.ind = TRUE);\n", " n <- length(ab[, 1]);\n", " \n", " # print('Make genes label CV matrix')\n", " if (!require('Matrix', quietly=TRUE)) {\n", " install.packages('Matrix')\n", " library(Matrix)\n", " }\n", " \n", " test.genes.labels <- matrix(genes.labels, nrow = g, ncol = nFold * l)\n", " test.genes.labels <- as(test.genes.labels,'sparseMatrix')\n", "\n", " # For each fold in each GO group, remove 1/nth of the values of the genes.label\n", " for (j in 1:l) {\n", " d <- which(ab[, 2] == j) # Which indices the genes are in this particular GO group\n", " t <- length(d) # Total number of genes in the GO group\n", " r <- sample(1:t, replace = FALSE)\n", " f <- t/nFold\n", " for (i in 1:nFold) {\n", " e <- c((1:f) + f * (i - 1))\n", " e <- sort(r[e])\n", " c <- j + l * (i - 1) # GO group to look at (ie column)\n", " test.genes.labels[ab[d], c][e] <- 0\n", " }\n", " }\n", "\n", " # print('Get sums - mat. mul.') sumin = ( t(network) %*% test.genes.labels) sumin <- ((network)\n", " # %*% test.genes.labels)\n", " sumin <- crossprod(network, test.genes.labels)\n", "\n", " # print('Get sums - calc sumall')\n", " sumall <- matrix(colSums(network), ncol = dim(sumin)[2], nrow = dim(sumin)[1])\n", "\n", " # print('Get sums - calc predicts')\n", " predicts <- sumin/sumall\n", " \n", " \n", " if (output == \"AUROC\") {\n", " # print('Hide training data')\n", " nans <- which(test.genes.labels == 1, arr.ind = TRUE)\n", "\n", " predicts[nans] <- NA\n", "\n", " if (!require('foreach', quietly=TRUE)) {\n", " install.packages('foreach')\n", " library(foreach)\n", " library(iterators)\n", " }\n", " library(iterators)\n", " predicts <- as.matrix(predicts)\n", " #print('Rank test data')\n", " predicts <- foreach(predicts=iter(predicts,by='col'),.combine=cbind) %dopar% (rank(abs(predicts),na.last = \"keep\", ties.method = \"average\"))\n", "\n", " # if (!require('parallel', quietly=TRUE)) {\n", " # install.packages('parallel')\n", " # library(parallel)\n", " # }\n", " # predicts <- as.matrix(predicts)\n", " # clust <- makeCluster(detectCores())\n", " # predicts <- parSapply(clust, predicts <- iter(predicts,by='col'), function(x) rank(abs(x),na.last = \"keep\", ties.method = \"average\"))\n", " # stopCluster(clust)\n", "\n", " filter <- matrix(genes.labels, nrow = g, ncol = nFold * l)\n", " negatives <- which(filter == 0, arr.ind = TRUE)\n", " positives <- which(filter == 1, arr.ind = TRUE)\n", "\n", " predicts[negatives] <- 0\n", " temp1 <- colSums(test.genes.labels)\n", " temp2 <- colSums(filter)\n", "\n", " # print('Calculate ROC - np')\n", " #np <- colSums(filter) - colSums(test.genes.labels) # Postives\n", " np <- temp2-temp1\n", "\n", " # print('Calculate ROC - nn')\n", " #nn <- dim(test.genes.labels)[1] - colSums(filter) # Negatives\n", " nn <- dim(test.genes.labels)[1] - temp2\n", "\n", " # print('Calculate ROC - p')\n", " p <- apply(predicts, 2, sum, na.rm = TRUE)\n", "\n", " # print('Calculate ROC - rocN')\n", " rocN <- (p/np - (np + 1)/2)/nn\n", " rocN <- matrix(rocN, ncol = nFold, nrow = l)\n", " rocN <- rowMeans(rocN)\n", "\n", " # print('Calculate node degree')\n", " node_degree <- rowSums(network)\n", " colsums <- colSums(genes.labels)\n", "\n", " # print('Calculate node degree - sum across gene labels')\n", " node_degree <- matrix(node_degree)\n", " temp <- t(node_degree) %*% genes.labels\n", "\n", " # print('Calculate node degree - average')\n", " average_node_degree <- t(temp)/colsums\n", "\n", " # print('Calculate node degree roc - rank node degree')\n", " ranks <- apply(abs(node_degree), 2, rank, na.last = \"keep\", ties.method = \"average\")\n", " ranks <- matrix(ranks, nrow = length(ranks), ncol = dim(genes.labels)[2])\n", "\n", " # print('Calculate node degree roc - remove negatives')\n", " negatives <- which(genes.labels == 0, arr.ind = TRUE)\n", " ranks[negatives] <- 0\n", "\n", " # print('Calculate node degree roc - np')\n", " np <- colSums(genes.labels)\n", "\n", " # print('Calculate node degree roc - nn')\n", " nn <- dim(genes.labels)[1] - np\n", "\n", " # print('Calculate node degree roc - p')\n", " p <- apply(ranks, 2, sum, na.rm = TRUE)\n", "\n", " # print('Calculate node degree roc - roc')\n", " roc <- (p/np - (np + 1)/2)/nn\n", " \n", " if (FLAG_DRAW == TRUE) {\n", " plot_roc_overlay(predicts, test.genes.labels)\n", " }\n", " \n", " scores <- cbind(\n", " auc=rocN,\n", " avg_node_degree=matrix(average_node_degree)[, 1],\n", " degree_null_auc=roc)\n", " } else if (output == \"PR\") {\n", " \n", " \tnans <- which(test.genes.labels == 1, arr.ind = TRUE)\n", " predicts[nans] <- NA\n", " filter <- matrix(genes.labels, nrow = g, ncol = nFold * l)\n", " negatives <- which(filter == 0, arr.ind = TRUE)\n", " positives <- which(filter == 1, arr.ind = TRUE)\n", "\n", " # print('Rank test data')\n", " if (!require('foreach', quietly=TRUE)) {\n", " install.packages('foreach')\n", " library(foreach)\n", " }\n", " library(iterators)\n", " predicts <- as.matrix(predicts)\n", " #print('Rank test data')\n", " predicts <- foreach(predicts=iter(predicts,by='col'),.combine=cbind) %dopar% (rank(-abs(predicts),na.last = \"keep\", ties.method = \"average\"))\n", " predicts[negatives] <- 0\n", "\n", " avgprc.s <- lapply(1:(nFold * l), function(i) \n", " mean( ( 1:length(which( sort(predicts[,i]) > 0 ) )\n", " / sort(predicts[,i])[ which( sort(predicts[,i]) > 0 )]), na.rm = TRUE) )\n", " \n", " n.s <- colSums(test.genes.labels)\n", " avgprc.null <- lapply(1:(nFold * l), function(i) n.s[i]/g)\n", " avgprc.null <- rowMeans(matrix(unlist(avgprc.null), ncol = nFold, nrow = l, byrow = FALSE), \n", " na.rm = TRUE)\n", "\n", " avgprc <- rowMeans(matrix(unlist(avgprc.s), ncol = nFold, nrow = l, byrow = FALSE), na.rm = TRUE)\n", " names(avgprc) <- colnames(genes.labels)\n", " \n", " # print('Calculate node degree')\n", " node_degree <- rowSums(network)\n", " colsums <- colSums(genes.labels)\n", " \n", " # print('Calculate node degree - sum across gene labels')\n", " node_degree <- matrix(node_degree)\n", " temp <- t(node_degree) %*% genes.labels\n", " \n", " \n", " # print('Calculate node degree - average')\n", " average_node_degree <- t(temp)/colsums\n", " \n", " scores <- cbind(\n", " avgprc=avgprc,\n", " avg_node_degree=matrix(average_node_degree)[, 1],\n", " degree_null_auc=avgprc.null)\n", " }\n", "\n", "\n", " return(scores)\n", "}" ] }, { "cell_type": "code", "execution_count": 3, "id": "c121fab1", "metadata": {}, "outputs": [ { "name": "stderr", "output_type": "stream", "text": [ "Warning message:\n", "“executing %dopar% sequentially: no parallel backend registered”\n" ] } ], "source": [ "genes.labels <- matrix( sample( c(0,1), 1000, replace=TRUE), nrow=100)\n", "rownames(genes.labels) = paste('gene', 1:100, sep='')\n", "colnames(genes.labels) = paste('function', 1:10, sep='')\n", "net <- cor( matrix( rnorm(10000), ncol=100), method='spearman')\n", "rownames(net) <- paste('gene', 1:100, sep='')\n", "colnames(net) <- paste('gene', 1:100, sep='')\n", "\n", "aurocs <- neighbor_voting(genes.labels, net, output = 'AUROC') \n", "\n", "avgprcs <- neighbor_voting(genes.labels, net, output = 'PR') " ] }, { "cell_type": "code", "execution_count": 41, "id": "b8bac3be", "metadata": {}, "outputs": [], "source": [ "file_path <- \"/grid/gillis/home/lohia/notebooks_cre_v3/notebooks/Notebooks_clean/input_go1.csv\"\n", "\n", "# Read the CSV file into a data frame with row names and headers\n", "data_frame <- read.csv(file_path, header = TRUE, row.names = 1)\n", "\n", "# Get the row names and column names from the data frame\n", "row_names <- rownames(data_frame)\n", "col_names <- colnames(data_frame)\n", "\n", "genes.labels <- as.matrix(data_frame)" ] }, { "cell_type": "code", "execution_count": 35, "id": "b1c84af9", "metadata": {}, "outputs": [ { "data": { "text/html": [ "\n", "\n", "\n", "\t\n", "\n", "\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\n", "
A matrix: 43 × 6 of type dbl
CGE.derivedMGE.derivedGlutGabaCGE.derived.1MGE.derived.1
Chandelier100110
Lamp5010101
Lamp5_Lhx6010101
Pax6010101
Pvalb100110
Sncg010101
Sst100110
Sst Chodl100110
Vip010101
L2/3 IT001000
L4 IT001000
L5 ET001000
L5 IT001000
L5/6 NP001000
L6 CT001000
L6 IT001000
L6 IT Car3001000
L6b001000
Astro000000
Endo000000
Micro-PVM000000
OPC000000
Oligo000000
VLMC000000
Adipocytes000000
Cardiomyocytes000000
Endocardial000000
Endothelial_Arterial000000
Endothelial_Capillaries000000
Endothelial_Other000000
Endothelial_Venous000000
Epicardium_FB-like000000
Epicardium_Meso000000
Epicardium_Proliferating000000
Fibroblasts000000
Immature_Cardiomyocytes000000
Immature_other000000
Lymphoid_Immune_Cells000000
Myeloid_Immune_Cells000000
Neuronal_Cells000000
Pericytes000000
Pericytes_Stromal000000
Smooth_Muscle_Cells000000
\n" ], "text/latex": [ "A matrix: 43 × 6 of type dbl\n", "\\begin{tabular}{r|llllll}\n", " & CGE.derived & MGE.derived & Glut & Gaba & CGE.derived.1 & MGE.derived.1\\\\\n", "\\hline\n", "\tChandelier & 1 & 0 & 0 & 1 & 1 & 0\\\\\n", "\tLamp5 & 0 & 1 & 0 & 1 & 0 & 1\\\\\n", "\tLamp5\\_Lhx6 & 0 & 1 & 0 & 1 & 0 & 1\\\\\n", "\tPax6 & 0 & 1 & 0 & 1 & 0 & 1\\\\\n", "\tPvalb & 1 & 0 & 0 & 1 & 1 & 0\\\\\n", "\tSncg & 0 & 1 & 0 & 1 & 0 & 1\\\\\n", "\tSst & 1 & 0 & 0 & 1 & 1 & 0\\\\\n", "\tSst Chodl & 1 & 0 & 0 & 1 & 1 & 0\\\\\n", "\tVip & 0 & 1 & 0 & 1 & 0 & 1\\\\\n", "\tL2/3 IT & 0 & 0 & 1 & 0 & 0 & 0\\\\\n", "\tL4 IT & 0 & 0 & 1 & 0 & 0 & 0\\\\\n", "\tL5 ET & 0 & 0 & 1 & 0 & 0 & 0\\\\\n", "\tL5 IT & 0 & 0 & 1 & 0 & 0 & 0\\\\\n", "\tL5/6 NP & 0 & 0 & 1 & 0 & 0 & 0\\\\\n", "\tL6 CT & 0 & 0 & 1 & 0 & 0 & 0\\\\\n", "\tL6 IT & 0 & 0 & 1 & 0 & 0 & 0\\\\\n", "\tL6 IT Car3 & 0 & 0 & 1 & 0 & 0 & 0\\\\\n", "\tL6b & 0 & 0 & 1 & 0 & 0 & 0\\\\\n", "\tAstro & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tEndo & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tMicro-PVM & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tOPC & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tOligo & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tVLMC & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tAdipocytes & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tCardiomyocytes & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tEndocardial & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tEndothelial\\_Arterial & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tEndothelial\\_Capillaries & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tEndothelial\\_Other & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tEndothelial\\_Venous & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tEpicardium\\_FB-like & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tEpicardium\\_Meso & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tEpicardium\\_Proliferating & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tFibroblasts & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tImmature\\_Cardiomyocytes & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tImmature\\_other & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tLymphoid\\_Immune\\_Cells & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tMyeloid\\_Immune\\_Cells & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tNeuronal\\_Cells & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tPericytes & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tPericytes\\_Stromal & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\tSmooth\\_Muscle\\_Cells & 0 & 0 & 0 & 0 & 0 & 0\\\\\n", "\\end{tabular}\n" ], "text/markdown": [ "\n", "A matrix: 43 × 6 of type dbl\n", "\n", "| | CGE.derived | MGE.derived | Glut | Gaba | CGE.derived.1 | MGE.derived.1 |\n", "|---|---|---|---|---|---|---|\n", "| Chandelier | 1 | 0 | 0 | 1 | 1 | 0 |\n", "| Lamp5 | 0 | 1 | 0 | 1 | 0 | 1 |\n", "| Lamp5_Lhx6 | 0 | 1 | 0 | 1 | 0 | 1 |\n", "| Pax6 | 0 | 1 | 0 | 1 | 0 | 1 |\n", "| Pvalb | 1 | 0 | 0 | 1 | 1 | 0 |\n", "| Sncg | 0 | 1 | 0 | 1 | 0 | 1 |\n", "| Sst | 1 | 0 | 0 | 1 | 1 | 0 |\n", "| Sst Chodl | 1 | 0 | 0 | 1 | 1 | 0 |\n", "| Vip | 0 | 1 | 0 | 1 | 0 | 1 |\n", "| L2/3 IT | 0 | 0 | 1 | 0 | 0 | 0 |\n", "| L4 IT | 0 | 0 | 1 | 0 | 0 | 0 |\n", "| L5 ET | 0 | 0 | 1 | 0 | 0 | 0 |\n", "| L5 IT | 0 | 0 | 1 | 0 | 0 | 0 |\n", "| L5/6 NP | 0 | 0 | 1 | 0 | 0 | 0 |\n", "| L6 CT | 0 | 0 | 1 | 0 | 0 | 0 |\n", "| L6 IT | 0 | 0 | 1 | 0 | 0 | 0 |\n", "| L6 IT Car3 | 0 | 0 | 1 | 0 | 0 | 0 |\n", "| L6b | 0 | 0 | 1 | 0 | 0 | 0 |\n", "| Astro | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Endo | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Micro-PVM | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| OPC | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Oligo | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| VLMC | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Adipocytes | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Cardiomyocytes | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Endocardial | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Endothelial_Arterial | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Endothelial_Capillaries | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Endothelial_Other | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Endothelial_Venous | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Epicardium_FB-like | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Epicardium_Meso | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Epicardium_Proliferating | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Fibroblasts | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Immature_Cardiomyocytes | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Immature_other | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Lymphoid_Immune_Cells | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Myeloid_Immune_Cells | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Neuronal_Cells | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Pericytes | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Pericytes_Stromal | 0 | 0 | 0 | 0 | 0 | 0 |\n", "| Smooth_Muscle_Cells | 0 | 0 | 0 | 0 | 0 | 0 |\n", "\n" ], "text/plain": [ " CGE.derived MGE.derived Glut Gaba CGE.derived.1\n", "Chandelier 1 0 0 1 1 \n", "Lamp5 0 1 0 1 0 \n", "Lamp5_Lhx6 0 1 0 1 0 \n", "Pax6 0 1 0 1 0 \n", "Pvalb 1 0 0 1 1 \n", "Sncg 0 1 0 1 0 \n", "Sst 1 0 0 1 1 \n", "Sst Chodl 1 0 0 1 1 \n", "Vip 0 1 0 1 0 \n", "L2/3 IT 0 0 1 0 0 \n", "L4 IT 0 0 1 0 0 \n", "L5 ET 0 0 1 0 0 \n", "L5 IT 0 0 1 0 0 \n", "L5/6 NP 0 0 1 0 0 \n", "L6 CT 0 0 1 0 0 \n", "L6 IT 0 0 1 0 0 \n", "L6 IT Car3 0 0 1 0 0 \n", "L6b 0 0 1 0 0 \n", "Astro 0 0 0 0 0 \n", "Endo 0 0 0 0 0 \n", "Micro-PVM 0 0 0 0 0 \n", "OPC 0 0 0 0 0 \n", "Oligo 0 0 0 0 0 \n", "VLMC 0 0 0 0 0 \n", "Adipocytes 0 0 0 0 0 \n", "Cardiomyocytes 0 0 0 0 0 \n", "Endocardial 0 0 0 0 0 \n", "Endothelial_Arterial 0 0 0 0 0 \n", "Endothelial_Capillaries 0 0 0 0 0 \n", "Endothelial_Other 0 0 0 0 0 \n", "Endothelial_Venous 0 0 0 0 0 \n", "Epicardium_FB-like 0 0 0 0 0 \n", "Epicardium_Meso 0 0 0 0 0 \n", "Epicardium_Proliferating 0 0 0 0 0 \n", "Fibroblasts 0 0 0 0 0 \n", "Immature_Cardiomyocytes 0 0 0 0 0 \n", "Immature_other 0 0 0 0 0 \n", "Lymphoid_Immune_Cells 0 0 0 0 0 \n", "Myeloid_Immune_Cells 0 0 0 0 0 \n", "Neuronal_Cells 0 0 0 0 0 \n", "Pericytes 0 0 0 0 0 \n", "Pericytes_Stromal 0 0 0 0 0 \n", "Smooth_Muscle_Cells 0 0 0 0 0 \n", " MGE.derived.1\n", "Chandelier 0 \n", "Lamp5 1 \n", "Lamp5_Lhx6 1 \n", "Pax6 1 \n", "Pvalb 0 \n", "Sncg 1 \n", "Sst 0 \n", "Sst Chodl 0 \n", "Vip 1 \n", "L2/3 IT 0 \n", "L4 IT 0 \n", "L5 ET 0 \n", "L5 IT 0 \n", "L5/6 NP 0 \n", "L6 CT 0 \n", "L6 IT 0 \n", "L6 IT Car3 0 \n", "L6b 0 \n", "Astro 0 \n", "Endo 0 \n", "Micro-PVM 0 \n", "OPC 0 \n", "Oligo 0 \n", "VLMC 0 \n", "Adipocytes 0 \n", "Cardiomyocytes 0 \n", "Endocardial 0 \n", "Endothelial_Arterial 0 \n", "Endothelial_Capillaries 0 \n", "Endothelial_Other 0 \n", "Endothelial_Venous 0 \n", "Epicardium_FB-like 0 \n", "Epicardium_Meso 0 \n", "Epicardium_Proliferating 0 \n", "Fibroblasts 0 \n", "Immature_Cardiomyocytes 0 \n", "Immature_other 0 \n", "Lymphoid_Immune_Cells 0 \n", "Myeloid_Immune_Cells 0 \n", "Neuronal_Cells 0 \n", "Pericytes 0 \n", "Pericytes_Stromal 0 \n", "Smooth_Muscle_Cells 0 " ] }, "metadata": {}, "output_type": "display_data" } ], "source": [ "genes.labels" ] }, { "cell_type": "code", "execution_count": 25, "id": "1a2cadbf", "metadata": {}, "outputs": [], "source": [ "file_path <- \"/grid/gillis/home/lohia/notebooks_cre_v3/notebooks/Notebooks_clean/input_nw.csv\"\n", "\n", "# Read the CSV file into a data frame with row names and headers\n", "data_frame <- read.csv(file_path, header = TRUE, row.names = 1)\n", "\n", "# Get the row names and column names from the data frame\n", "row_names <- colnames(data_frame)\n", "col_names <- colnames(data_frame)\n", "\n", "net <- as.matrix(data_frame)" ] }, { "cell_type": "code", "execution_count": 26, "id": "308d0dbb", "metadata": {}, "outputs": [ { "data": { "text/html": [ "\n", "\n", "\n", "\t\n", "\n", "\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\t\n", "\n", "
A matrix: 43 × 43 of type dbl
ChandelierLamp5Lamp5_Lhx6Pax6PvalbSncgSstSst.ChodlVipL2.3.ITEpicardium_ProliferatingFibroblastsImmature_CardiomyocytesImmature_otherLymphoid_Immune_CellsMyeloid_Immune_CellsNeuronal_CellsPericytesPericytes_StromalSmooth_Muscle_Cells
Chandelier1.203307580.159685280.152917850.045112770.163255790.242616590.215844320.193182520.173984190.166698070.177058910.103881160.1417867910.176498770.180825530.208421590.175876690.130486580.141993070.23997149
Lamp50.159685281.203307580.129250420.167902640.190956690.203779690.195726060.084711940.229591040.214806990.289334580.196330430.0239865480.102456100.150501980.092800530.240868130.149597180.149343930.15382051
Lamp5_Lhx60.152917850.129250421.203307580.190730920.211969270.140348490.298903080.195680270.196905240.144930240.190400960.321413700.1998849520.201955810.233370460.129854900.252501280.142661070.173503790.17849828
Pax60.045112770.167902640.190730921.203307580.227178990.243496190.212705950.221600090.169888840.194012650.084370400.268746980.2424618390.126461930.160217230.237287940.140405300.261363300.206631960.18134501
Pvalb0.163255790.190956690.211969270.227178991.203307580.233526320.174591370.140998360.149900110.226698090.138075280.190841030.1576926050.182335460.225909040.073666060.185890630.197153910.171154530.19725048
Sncg0.242616590.203779690.140348490.243496190.233526321.203307580.180960490.092668340.112798160.225854410.275131370.199147230.1399011270.123739870.260199200.141019850.091723870.200741490.084358490.12349269
Sst0.215844320.195726060.298903080.212705950.174591370.180960491.203307580.149547630.144570340.174007220.297969960.167070020.1913792760.211126100.155010660.099659990.169828080.070933230.250576560.22148024
Sst Chodl0.193182520.084711940.195680270.221600090.140998360.092668340.149547631.203307580.056678610.136629740.150030330.141726860.2919096950.290763810.101958420.231113440.136923140.105467800.154221500.30739960
Vip0.173984190.229591040.196905240.169888840.149900110.112798160.144570340.056678611.203307580.195382630.039224380.119038390.0776559890.182960690.303668490.160916880.211903330.185586870.121736540.16263191
L2/3 IT0.166698070.214806990.144930240.194012650.226698090.225854410.174007220.136629740.195382631.203307580.150735570.015526710.1652711480.185350560.153350700.215502800.179175970.164172890.275677730.22575832
L4 IT0.164716370.252503090.068926630.136715720.184748210.170503930.089208770.230940390.244670760.278714740.044581680.000000000.1809371000.158695560.139002250.182901240.137158590.133950650.136778530.16144940
L5 ET0.207065680.193601760.144155340.118564500.183461700.134123120.101139380.271321230.092261300.170750560.115900890.134679620.1709401350.162515910.054722280.105974120.161881190.216495880.167439130.12237632
L5 IT0.162423330.137328420.180828270.173267120.194423050.209469110.245912010.270643300.136662890.181655600.250958680.163970680.1910983640.192239190.051215930.049556910.170541800.151255230.290453730.15596546
L5/6 NP0.176825100.171684300.222101320.302722530.238615050.175402410.110774890.177327800.255056140.205241380.127608370.172041510.0898768480.162538130.193122000.157840610.179737370.250556010.099184090.16351599
L6 CT0.136741890.124459420.200636020.090331070.072389370.039895050.146367780.182730300.121289810.153495040.207309300.228642280.1704331360.295030560.096470940.125096750.196546700.197179370.154742050.12163607
L6 IT0.157235060.211278790.193730850.198332350.268681430.231473160.075152430.229129200.151452550.117609250.115332030.202819530.2075336700.117947850.112037110.112565090.062984560.161413620.079574940.17575141
L6 IT Car30.166962870.069456300.272142790.169867780.242447000.113501170.171549770.204283680.175960880.167688660.014953140.151916490.1602997500.166215980.158255690.121413040.185262030.235167730.141656760.10925536
L6b0.160769990.166528220.251814040.156026380.194028990.176951790.177012780.143076020.252855120.224335180.111822010.140722080.0774470940.140829220.223192000.175944500.157194530.214651620.177897200.12589230
Astro0.211035660.233854110.065291840.196508940.175227620.103989790.168216270.177161510.169138980.240402250.171599640.169198160.1496386410.188391780.071731190.257630220.191709590.114012550.176704880.22043572
Endo0.197153390.130718210.186896690.117359370.145844750.166464740.095932770.181240340.264133740.211454600.130091180.087050640.1623650970.206851080.229200210.238508140.207226260.212819810.196842880.08770064
Micro-PVM0.128333900.220157160.127931230.209540850.119183980.129203440.181079930.242708860.233993000.131460600.187141300.157631620.3806384230.204983880.180480490.232989130.169629490.209393840.162593080.19155615
OPC0.159199480.353455360.164654690.173940190.273439470.171493380.190495820.022869250.225140970.179719010.176793110.214809610.0096325540.126003150.221408710.115810340.221542670.165427880.185672320.08520339
Oligo0.283656810.111032420.163781440.062389680.124390200.178551150.175995170.300433590.151985650.178758970.200109900.100154790.1968842190.243706790.170868930.231151760.154544180.264493380.178574500.19026731
VLMC0.232596360.161061320.158253260.180580310.113914970.121615840.212856510.133840450.361388950.126167890.145993430.164224260.0503131430.273432860.149352780.168954010.094381750.261451240.055906330.16802478
Adipocytes0.216709940.183466020.076062540.140974670.150016980.146038560.165293560.202641550.219677330.209115560.173091580.173492940.1844557760.234429370.174454360.273410560.339992260.134452040.208363690.15980914
Cardiomyocytes0.173358770.154762260.099587960.228877720.168610210.215372100.257139000.192380280.247395400.156023270.201596020.120865220.2184252850.143305810.273411870.213353680.263186580.108545420.227796830.17123438
Endocardial0.160247880.202763490.050841340.145856960.126655140.287354280.096009710.095555070.214016990.251395910.180336710.079152210.1382905250.133584880.239065120.197844770.099732700.241147510.092348030.15411904
Endothelial_Arterial0.156548610.169122020.257632020.116804390.222190580.102606680.262563100.172099250.201605320.156167680.150339060.135187350.1553633850.183647170.202750260.147136160.219818660.168410180.154273250.10765485
Endothelial_Capillaries0.163689280.168743330.052598190.142152340.145497870.093391330.082256450.202674840.165640210.332352690.189026480.113388970.1354091550.250750670.203774800.329962120.185563040.160284250.294289530.28338876
Endothelial_Other0.230104750.115133130.149709710.139644630.146427370.130598240.177265620.357255620.086902450.125201010.177899530.089939340.2705842390.283458870.098142870.219923830.216688890.114648980.127263410.22407439
Endothelial_Venous0.178608940.144098900.208820430.220018730.104508040.239376140.247320790.066892230.192124870.089243950.182270000.293013630.2409613320.099529250.284102330.183551990.192595570.181990590.223563530.18093872
Epicardium_FB-like0.260541450.106271460.170714640.213553220.246769040.186055560.150446940.175386250.142758880.085785760.156457590.326366850.2370783410.082210060.392126590.238698770.228588490.104470980.262130580.10866140
Epicardium_Meso0.200559050.206889710.089649450.128362720.139707290.350360100.136609540.105171060.134480400.147145380.274226810.220293470.1118607620.058635550.193734600.173405290.106733590.226342160.206497800.22516512
Epicardium_Proliferating0.177058910.289334580.190400960.084370400.138075280.275131370.297969960.150030330.039224380.150735571.203307580.280655610.1353004270.296771170.127385900.094079910.218278360.057572510.290018180.10552753
Fibroblasts0.103881160.196330430.321413700.268746980.190841030.199147230.167070020.141726860.119038390.015526710.280655611.203307580.2763765570.152596640.182518380.171313390.227554810.218024150.180699490.22934513
Immature_Cardiomyocytes0.141786790.023986550.199884950.242461840.157692600.139901130.191379280.291909700.077655990.165271150.135300430.276376561.2033075770.166570480.177998320.233749830.155725970.133952770.229725270.34749988
Immature_other0.176498770.102456100.201955810.126461930.182335460.123739870.211126100.290763810.182960690.185350560.296771170.152596640.1665704761.203307580.168539450.169423600.264119230.186659410.199722450.11365390
Lymphoid_Immune_Cells0.180825530.150501980.233370460.160217230.225909040.260199200.155010660.101958420.303668490.153350700.127385900.182518380.1779983160.168539451.203307580.262127230.228122290.189034990.210811570.22853502
Myeloid_Immune_Cells0.208421590.092800530.129854900.237287940.073666060.141019850.099659990.231113440.160916880.215502800.094079910.171313390.2337498320.169423600.262127231.203307580.265601750.190747060.282364570.27832889
Neuronal_Cells0.175876690.240868130.252501280.140405300.185890630.091723870.169828080.136923140.211903330.179175970.218278360.227554810.1557259660.264119230.228122290.265601751.203307580.085958710.232466360.13490425
Pericytes0.130486580.149597180.142661070.261363300.197153910.200741490.070933230.105467800.185586870.164172890.057572510.218024150.1339527690.186659410.189034990.190747060.085958711.203307580.124104550.08175493
Pericytes_Stromal0.141993070.149343930.173503790.206631960.171154530.084358490.250576560.154221500.121736540.275677730.290018180.180699490.2297252680.199722450.210811570.282364570.232466360.124104551.203307580.21587325
Smooth_Muscle_Cells0.239971490.153820510.178498280.181345010.197250480.123492690.221480240.307399600.162631910.225758320.105527530.229345130.3474998850.113653900.228535020.278328890.134904250.081754930.215873251.20330758
\n" ], "text/latex": [ "A matrix: 43 × 43 of type dbl\n", "\\begin{tabular}{r|lllllllllllllllllllll}\n", " & Chandelier & Lamp5 & Lamp5\\_Lhx6 & Pax6 & Pvalb & Sncg & Sst & Sst.Chodl & Vip & L2.3.IT & ⋯ & Epicardium\\_Proliferating & Fibroblasts & Immature\\_Cardiomyocytes & Immature\\_other & Lymphoid\\_Immune\\_Cells & Myeloid\\_Immune\\_Cells & Neuronal\\_Cells & Pericytes & Pericytes\\_Stromal & Smooth\\_Muscle\\_Cells\\\\\n", "\\hline\n", "\tChandelier & 1.20330758 & 0.15968528 & 0.15291785 & 0.04511277 & 0.16325579 & 0.24261659 & 0.21584432 & 0.19318252 & 0.17398419 & 0.16669807 & ⋯ & 0.17705891 & 0.10388116 & 0.141786791 & 0.17649877 & 0.18082553 & 0.20842159 & 0.17587669 & 0.13048658 & 0.14199307 & 0.23997149\\\\\n", "\tLamp5 & 0.15968528 & 1.20330758 & 0.12925042 & 0.16790264 & 0.19095669 & 0.20377969 & 0.19572606 & 0.08471194 & 0.22959104 & 0.21480699 & ⋯ & 0.28933458 & 0.19633043 & 0.023986548 & 0.10245610 & 0.15050198 & 0.09280053 & 0.24086813 & 0.14959718 & 0.14934393 & 0.15382051\\\\\n", "\tLamp5\\_Lhx6 & 0.15291785 & 0.12925042 & 1.20330758 & 0.19073092 & 0.21196927 & 0.14034849 & 0.29890308 & 0.19568027 & 0.19690524 & 0.14493024 & ⋯ & 0.19040096 & 0.32141370 & 0.199884952 & 0.20195581 & 0.23337046 & 0.12985490 & 0.25250128 & 0.14266107 & 0.17350379 & 0.17849828\\\\\n", "\tPax6 & 0.04511277 & 0.16790264 & 0.19073092 & 1.20330758 & 0.22717899 & 0.24349619 & 0.21270595 & 0.22160009 & 0.16988884 & 0.19401265 & ⋯ & 0.08437040 & 0.26874698 & 0.242461839 & 0.12646193 & 0.16021723 & 0.23728794 & 0.14040530 & 0.26136330 & 0.20663196 & 0.18134501\\\\\n", "\tPvalb & 0.16325579 & 0.19095669 & 0.21196927 & 0.22717899 & 1.20330758 & 0.23352632 & 0.17459137 & 0.14099836 & 0.14990011 & 0.22669809 & ⋯ & 0.13807528 & 0.19084103 & 0.157692605 & 0.18233546 & 0.22590904 & 0.07366606 & 0.18589063 & 0.19715391 & 0.17115453 & 0.19725048\\\\\n", "\tSncg & 0.24261659 & 0.20377969 & 0.14034849 & 0.24349619 & 0.23352632 & 1.20330758 & 0.18096049 & 0.09266834 & 0.11279816 & 0.22585441 & ⋯ & 0.27513137 & 0.19914723 & 0.139901127 & 0.12373987 & 0.26019920 & 0.14101985 & 0.09172387 & 0.20074149 & 0.08435849 & 0.12349269\\\\\n", "\tSst & 0.21584432 & 0.19572606 & 0.29890308 & 0.21270595 & 0.17459137 & 0.18096049 & 1.20330758 & 0.14954763 & 0.14457034 & 0.17400722 & ⋯ & 0.29796996 & 0.16707002 & 0.191379276 & 0.21112610 & 0.15501066 & 0.09965999 & 0.16982808 & 0.07093323 & 0.25057656 & 0.22148024\\\\\n", "\tSst Chodl & 0.19318252 & 0.08471194 & 0.19568027 & 0.22160009 & 0.14099836 & 0.09266834 & 0.14954763 & 1.20330758 & 0.05667861 & 0.13662974 & ⋯ & 0.15003033 & 0.14172686 & 0.291909695 & 0.29076381 & 0.10195842 & 0.23111344 & 0.13692314 & 0.10546780 & 0.15422150 & 0.30739960\\\\\n", "\tVip & 0.17398419 & 0.22959104 & 0.19690524 & 0.16988884 & 0.14990011 & 0.11279816 & 0.14457034 & 0.05667861 & 1.20330758 & 0.19538263 & ⋯ & 0.03922438 & 0.11903839 & 0.077655989 & 0.18296069 & 0.30366849 & 0.16091688 & 0.21190333 & 0.18558687 & 0.12173654 & 0.16263191\\\\\n", "\tL2/3 IT & 0.16669807 & 0.21480699 & 0.14493024 & 0.19401265 & 0.22669809 & 0.22585441 & 0.17400722 & 0.13662974 & 0.19538263 & 1.20330758 & ⋯ & 0.15073557 & 0.01552671 & 0.165271148 & 0.18535056 & 0.15335070 & 0.21550280 & 0.17917597 & 0.16417289 & 0.27567773 & 0.22575832\\\\\n", "\tL4 IT & 0.16471637 & 0.25250309 & 0.06892663 & 0.13671572 & 0.18474821 & 0.17050393 & 0.08920877 & 0.23094039 & 0.24467076 & 0.27871474 & ⋯ & 0.04458168 & 0.00000000 & 0.180937100 & 0.15869556 & 0.13900225 & 0.18290124 & 0.13715859 & 0.13395065 & 0.13677853 & 0.16144940\\\\\n", "\tL5 ET & 0.20706568 & 0.19360176 & 0.14415534 & 0.11856450 & 0.18346170 & 0.13412312 & 0.10113938 & 0.27132123 & 0.09226130 & 0.17075056 & ⋯ & 0.11590089 & 0.13467962 & 0.170940135 & 0.16251591 & 0.05472228 & 0.10597412 & 0.16188119 & 0.21649588 & 0.16743913 & 0.12237632\\\\\n", "\tL5 IT & 0.16242333 & 0.13732842 & 0.18082827 & 0.17326712 & 0.19442305 & 0.20946911 & 0.24591201 & 0.27064330 & 0.13666289 & 0.18165560 & ⋯ & 0.25095868 & 0.16397068 & 0.191098364 & 0.19223919 & 0.05121593 & 0.04955691 & 0.17054180 & 0.15125523 & 0.29045373 & 0.15596546\\\\\n", "\tL5/6 NP & 0.17682510 & 0.17168430 & 0.22210132 & 0.30272253 & 0.23861505 & 0.17540241 & 0.11077489 & 0.17732780 & 0.25505614 & 0.20524138 & ⋯ & 0.12760837 & 0.17204151 & 0.089876848 & 0.16253813 & 0.19312200 & 0.15784061 & 0.17973737 & 0.25055601 & 0.09918409 & 0.16351599\\\\\n", "\tL6 CT & 0.13674189 & 0.12445942 & 0.20063602 & 0.09033107 & 0.07238937 & 0.03989505 & 0.14636778 & 0.18273030 & 0.12128981 & 0.15349504 & ⋯ & 0.20730930 & 0.22864228 & 0.170433136 & 0.29503056 & 0.09647094 & 0.12509675 & 0.19654670 & 0.19717937 & 0.15474205 & 0.12163607\\\\\n", "\tL6 IT & 0.15723506 & 0.21127879 & 0.19373085 & 0.19833235 & 0.26868143 & 0.23147316 & 0.07515243 & 0.22912920 & 0.15145255 & 0.11760925 & ⋯ & 0.11533203 & 0.20281953 & 0.207533670 & 0.11794785 & 0.11203711 & 0.11256509 & 0.06298456 & 0.16141362 & 0.07957494 & 0.17575141\\\\\n", "\tL6 IT Car3 & 0.16696287 & 0.06945630 & 0.27214279 & 0.16986778 & 0.24244700 & 0.11350117 & 0.17154977 & 0.20428368 & 0.17596088 & 0.16768866 & ⋯ & 0.01495314 & 0.15191649 & 0.160299750 & 0.16621598 & 0.15825569 & 0.12141304 & 0.18526203 & 0.23516773 & 0.14165676 & 0.10925536\\\\\n", "\tL6b & 0.16076999 & 0.16652822 & 0.25181404 & 0.15602638 & 0.19402899 & 0.17695179 & 0.17701278 & 0.14307602 & 0.25285512 & 0.22433518 & ⋯ & 0.11182201 & 0.14072208 & 0.077447094 & 0.14082922 & 0.22319200 & 0.17594450 & 0.15719453 & 0.21465162 & 0.17789720 & 0.12589230\\\\\n", "\tAstro & 0.21103566 & 0.23385411 & 0.06529184 & 0.19650894 & 0.17522762 & 0.10398979 & 0.16821627 & 0.17716151 & 0.16913898 & 0.24040225 & ⋯ & 0.17159964 & 0.16919816 & 0.149638641 & 0.18839178 & 0.07173119 & 0.25763022 & 0.19170959 & 0.11401255 & 0.17670488 & 0.22043572\\\\\n", "\tEndo & 0.19715339 & 0.13071821 & 0.18689669 & 0.11735937 & 0.14584475 & 0.16646474 & 0.09593277 & 0.18124034 & 0.26413374 & 0.21145460 & ⋯ & 0.13009118 & 0.08705064 & 0.162365097 & 0.20685108 & 0.22920021 & 0.23850814 & 0.20722626 & 0.21281981 & 0.19684288 & 0.08770064\\\\\n", "\tMicro-PVM & 0.12833390 & 0.22015716 & 0.12793123 & 0.20954085 & 0.11918398 & 0.12920344 & 0.18107993 & 0.24270886 & 0.23399300 & 0.13146060 & ⋯ & 0.18714130 & 0.15763162 & 0.380638423 & 0.20498388 & 0.18048049 & 0.23298913 & 0.16962949 & 0.20939384 & 0.16259308 & 0.19155615\\\\\n", "\tOPC & 0.15919948 & 0.35345536 & 0.16465469 & 0.17394019 & 0.27343947 & 0.17149338 & 0.19049582 & 0.02286925 & 0.22514097 & 0.17971901 & ⋯ & 0.17679311 & 0.21480961 & 0.009632554 & 0.12600315 & 0.22140871 & 0.11581034 & 0.22154267 & 0.16542788 & 0.18567232 & 0.08520339\\\\\n", "\tOligo & 0.28365681 & 0.11103242 & 0.16378144 & 0.06238968 & 0.12439020 & 0.17855115 & 0.17599517 & 0.30043359 & 0.15198565 & 0.17875897 & ⋯ & 0.20010990 & 0.10015479 & 0.196884219 & 0.24370679 & 0.17086893 & 0.23115176 & 0.15454418 & 0.26449338 & 0.17857450 & 0.19026731\\\\\n", "\tVLMC & 0.23259636 & 0.16106132 & 0.15825326 & 0.18058031 & 0.11391497 & 0.12161584 & 0.21285651 & 0.13384045 & 0.36138895 & 0.12616789 & ⋯ & 0.14599343 & 0.16422426 & 0.050313143 & 0.27343286 & 0.14935278 & 0.16895401 & 0.09438175 & 0.26145124 & 0.05590633 & 0.16802478\\\\\n", "\tAdipocytes & 0.21670994 & 0.18346602 & 0.07606254 & 0.14097467 & 0.15001698 & 0.14603856 & 0.16529356 & 0.20264155 & 0.21967733 & 0.20911556 & ⋯ & 0.17309158 & 0.17349294 & 0.184455776 & 0.23442937 & 0.17445436 & 0.27341056 & 0.33999226 & 0.13445204 & 0.20836369 & 0.15980914\\\\\n", "\tCardiomyocytes & 0.17335877 & 0.15476226 & 0.09958796 & 0.22887772 & 0.16861021 & 0.21537210 & 0.25713900 & 0.19238028 & 0.24739540 & 0.15602327 & ⋯ & 0.20159602 & 0.12086522 & 0.218425285 & 0.14330581 & 0.27341187 & 0.21335368 & 0.26318658 & 0.10854542 & 0.22779683 & 0.17123438\\\\\n", "\tEndocardial & 0.16024788 & 0.20276349 & 0.05084134 & 0.14585696 & 0.12665514 & 0.28735428 & 0.09600971 & 0.09555507 & 0.21401699 & 0.25139591 & ⋯ & 0.18033671 & 0.07915221 & 0.138290525 & 0.13358488 & 0.23906512 & 0.19784477 & 0.09973270 & 0.24114751 & 0.09234803 & 0.15411904\\\\\n", "\tEndothelial\\_Arterial & 0.15654861 & 0.16912202 & 0.25763202 & 0.11680439 & 0.22219058 & 0.10260668 & 0.26256310 & 0.17209925 & 0.20160532 & 0.15616768 & ⋯ & 0.15033906 & 0.13518735 & 0.155363385 & 0.18364717 & 0.20275026 & 0.14713616 & 0.21981866 & 0.16841018 & 0.15427325 & 0.10765485\\\\\n", "\tEndothelial\\_Capillaries & 0.16368928 & 0.16874333 & 0.05259819 & 0.14215234 & 0.14549787 & 0.09339133 & 0.08225645 & 0.20267484 & 0.16564021 & 0.33235269 & ⋯ & 0.18902648 & 0.11338897 & 0.135409155 & 0.25075067 & 0.20377480 & 0.32996212 & 0.18556304 & 0.16028425 & 0.29428953 & 0.28338876\\\\\n", "\tEndothelial\\_Other & 0.23010475 & 0.11513313 & 0.14970971 & 0.13964463 & 0.14642737 & 0.13059824 & 0.17726562 & 0.35725562 & 0.08690245 & 0.12520101 & ⋯ & 0.17789953 & 0.08993934 & 0.270584239 & 0.28345887 & 0.09814287 & 0.21992383 & 0.21668889 & 0.11464898 & 0.12726341 & 0.22407439\\\\\n", "\tEndothelial\\_Venous & 0.17860894 & 0.14409890 & 0.20882043 & 0.22001873 & 0.10450804 & 0.23937614 & 0.24732079 & 0.06689223 & 0.19212487 & 0.08924395 & ⋯ & 0.18227000 & 0.29301363 & 0.240961332 & 0.09952925 & 0.28410233 & 0.18355199 & 0.19259557 & 0.18199059 & 0.22356353 & 0.18093872\\\\\n", "\tEpicardium\\_FB-like & 0.26054145 & 0.10627146 & 0.17071464 & 0.21355322 & 0.24676904 & 0.18605556 & 0.15044694 & 0.17538625 & 0.14275888 & 0.08578576 & ⋯ & 0.15645759 & 0.32636685 & 0.237078341 & 0.08221006 & 0.39212659 & 0.23869877 & 0.22858849 & 0.10447098 & 0.26213058 & 0.10866140\\\\\n", "\tEpicardium\\_Meso & 0.20055905 & 0.20688971 & 0.08964945 & 0.12836272 & 0.13970729 & 0.35036010 & 0.13660954 & 0.10517106 & 0.13448040 & 0.14714538 & ⋯ & 0.27422681 & 0.22029347 & 0.111860762 & 0.05863555 & 0.19373460 & 0.17340529 & 0.10673359 & 0.22634216 & 0.20649780 & 0.22516512\\\\\n", "\tEpicardium\\_Proliferating & 0.17705891 & 0.28933458 & 0.19040096 & 0.08437040 & 0.13807528 & 0.27513137 & 0.29796996 & 0.15003033 & 0.03922438 & 0.15073557 & ⋯ & 1.20330758 & 0.28065561 & 0.135300427 & 0.29677117 & 0.12738590 & 0.09407991 & 0.21827836 & 0.05757251 & 0.29001818 & 0.10552753\\\\\n", "\tFibroblasts & 0.10388116 & 0.19633043 & 0.32141370 & 0.26874698 & 0.19084103 & 0.19914723 & 0.16707002 & 0.14172686 & 0.11903839 & 0.01552671 & ⋯ & 0.28065561 & 1.20330758 & 0.276376557 & 0.15259664 & 0.18251838 & 0.17131339 & 0.22755481 & 0.21802415 & 0.18069949 & 0.22934513\\\\\n", "\tImmature\\_Cardiomyocytes & 0.14178679 & 0.02398655 & 0.19988495 & 0.24246184 & 0.15769260 & 0.13990113 & 0.19137928 & 0.29190970 & 0.07765599 & 0.16527115 & ⋯ & 0.13530043 & 0.27637656 & 1.203307577 & 0.16657048 & 0.17799832 & 0.23374983 & 0.15572597 & 0.13395277 & 0.22972527 & 0.34749988\\\\\n", "\tImmature\\_other & 0.17649877 & 0.10245610 & 0.20195581 & 0.12646193 & 0.18233546 & 0.12373987 & 0.21112610 & 0.29076381 & 0.18296069 & 0.18535056 & ⋯ & 0.29677117 & 0.15259664 & 0.166570476 & 1.20330758 & 0.16853945 & 0.16942360 & 0.26411923 & 0.18665941 & 0.19972245 & 0.11365390\\\\\n", "\tLymphoid\\_Immune\\_Cells & 0.18082553 & 0.15050198 & 0.23337046 & 0.16021723 & 0.22590904 & 0.26019920 & 0.15501066 & 0.10195842 & 0.30366849 & 0.15335070 & ⋯ & 0.12738590 & 0.18251838 & 0.177998316 & 0.16853945 & 1.20330758 & 0.26212723 & 0.22812229 & 0.18903499 & 0.21081157 & 0.22853502\\\\\n", "\tMyeloid\\_Immune\\_Cells & 0.20842159 & 0.09280053 & 0.12985490 & 0.23728794 & 0.07366606 & 0.14101985 & 0.09965999 & 0.23111344 & 0.16091688 & 0.21550280 & ⋯ & 0.09407991 & 0.17131339 & 0.233749832 & 0.16942360 & 0.26212723 & 1.20330758 & 0.26560175 & 0.19074706 & 0.28236457 & 0.27832889\\\\\n", "\tNeuronal\\_Cells & 0.17587669 & 0.24086813 & 0.25250128 & 0.14040530 & 0.18589063 & 0.09172387 & 0.16982808 & 0.13692314 & 0.21190333 & 0.17917597 & ⋯ & 0.21827836 & 0.22755481 & 0.155725966 & 0.26411923 & 0.22812229 & 0.26560175 & 1.20330758 & 0.08595871 & 0.23246636 & 0.13490425\\\\\n", "\tPericytes & 0.13048658 & 0.14959718 & 0.14266107 & 0.26136330 & 0.19715391 & 0.20074149 & 0.07093323 & 0.10546780 & 0.18558687 & 0.16417289 & ⋯ & 0.05757251 & 0.21802415 & 0.133952769 & 0.18665941 & 0.18903499 & 0.19074706 & 0.08595871 & 1.20330758 & 0.12410455 & 0.08175493\\\\\n", "\tPericytes\\_Stromal & 0.14199307 & 0.14934393 & 0.17350379 & 0.20663196 & 0.17115453 & 0.08435849 & 0.25057656 & 0.15422150 & 0.12173654 & 0.27567773 & ⋯ & 0.29001818 & 0.18069949 & 0.229725268 & 0.19972245 & 0.21081157 & 0.28236457 & 0.23246636 & 0.12410455 & 1.20330758 & 0.21587325\\\\\n", "\tSmooth\\_Muscle\\_Cells & 0.23997149 & 0.15382051 & 0.17849828 & 0.18134501 & 0.19725048 & 0.12349269 & 0.22148024 & 0.30739960 & 0.16263191 & 0.22575832 & ⋯ & 0.10552753 & 0.22934513 & 0.347499885 & 0.11365390 & 0.22853502 & 0.27832889 & 0.13490425 & 0.08175493 & 0.21587325 & 1.20330758\\\\\n", "\\end{tabular}\n" ], "text/markdown": [ "\n", "A matrix: 43 × 43 of type dbl\n", "\n", "| | Chandelier | Lamp5 | Lamp5_Lhx6 | Pax6 | Pvalb | Sncg | Sst | Sst.Chodl | Vip | L2.3.IT | ⋯ | Epicardium_Proliferating | Fibroblasts | Immature_Cardiomyocytes | Immature_other | Lymphoid_Immune_Cells | Myeloid_Immune_Cells | Neuronal_Cells | Pericytes | Pericytes_Stromal | Smooth_Muscle_Cells |\n", "|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|---|\n", "| Chandelier | 1.20330758 | 0.15968528 | 0.15291785 | 0.04511277 | 0.16325579 | 0.24261659 | 0.21584432 | 0.19318252 | 0.17398419 | 0.16669807 | ⋯ | 0.17705891 | 0.10388116 | 0.141786791 | 0.17649877 | 0.18082553 | 0.20842159 | 0.17587669 | 0.13048658 | 0.14199307 | 0.23997149 |\n", "| Lamp5 | 0.15968528 | 1.20330758 | 0.12925042 | 0.16790264 | 0.19095669 | 0.20377969 | 0.19572606 | 0.08471194 | 0.22959104 | 0.21480699 | ⋯ | 0.28933458 | 0.19633043 | 0.023986548 | 0.10245610 | 0.15050198 | 0.09280053 | 0.24086813 | 0.14959718 | 0.14934393 | 0.15382051 |\n", "| Lamp5_Lhx6 | 0.15291785 | 0.12925042 | 1.20330758 | 0.19073092 | 0.21196927 | 0.14034849 | 0.29890308 | 0.19568027 | 0.19690524 | 0.14493024 | ⋯ | 0.19040096 | 0.32141370 | 0.199884952 | 0.20195581 | 0.23337046 | 0.12985490 | 0.25250128 | 0.14266107 | 0.17350379 | 0.17849828 |\n", "| Pax6 | 0.04511277 | 0.16790264 | 0.19073092 | 1.20330758 | 0.22717899 | 0.24349619 | 0.21270595 | 0.22160009 | 0.16988884 | 0.19401265 | ⋯ | 0.08437040 | 0.26874698 | 0.242461839 | 0.12646193 | 0.16021723 | 0.23728794 | 0.14040530 | 0.26136330 | 0.20663196 | 0.18134501 |\n", "| Pvalb | 0.16325579 | 0.19095669 | 0.21196927 | 0.22717899 | 1.20330758 | 0.23352632 | 0.17459137 | 0.14099836 | 0.14990011 | 0.22669809 | ⋯ | 0.13807528 | 0.19084103 | 0.157692605 | 0.18233546 | 0.22590904 | 0.07366606 | 0.18589063 | 0.19715391 | 0.17115453 | 0.19725048 |\n", "| Sncg | 0.24261659 | 0.20377969 | 0.14034849 | 0.24349619 | 0.23352632 | 1.20330758 | 0.18096049 | 0.09266834 | 0.11279816 | 0.22585441 | ⋯ | 0.27513137 | 0.19914723 | 0.139901127 | 0.12373987 | 0.26019920 | 0.14101985 | 0.09172387 | 0.20074149 | 0.08435849 | 0.12349269 |\n", "| Sst | 0.21584432 | 0.19572606 | 0.29890308 | 0.21270595 | 0.17459137 | 0.18096049 | 1.20330758 | 0.14954763 | 0.14457034 | 0.17400722 | ⋯ | 0.29796996 | 0.16707002 | 0.191379276 | 0.21112610 | 0.15501066 | 0.09965999 | 0.16982808 | 0.07093323 | 0.25057656 | 0.22148024 |\n", "| Sst Chodl | 0.19318252 | 0.08471194 | 0.19568027 | 0.22160009 | 0.14099836 | 0.09266834 | 0.14954763 | 1.20330758 | 0.05667861 | 0.13662974 | ⋯ | 0.15003033 | 0.14172686 | 0.291909695 | 0.29076381 | 0.10195842 | 0.23111344 | 0.13692314 | 0.10546780 | 0.15422150 | 0.30739960 |\n", "| Vip | 0.17398419 | 0.22959104 | 0.19690524 | 0.16988884 | 0.14990011 | 0.11279816 | 0.14457034 | 0.05667861 | 1.20330758 | 0.19538263 | ⋯ | 0.03922438 | 0.11903839 | 0.077655989 | 0.18296069 | 0.30366849 | 0.16091688 | 0.21190333 | 0.18558687 | 0.12173654 | 0.16263191 |\n", "| L2/3 IT | 0.16669807 | 0.21480699 | 0.14493024 | 0.19401265 | 0.22669809 | 0.22585441 | 0.17400722 | 0.13662974 | 0.19538263 | 1.20330758 | ⋯ | 0.15073557 | 0.01552671 | 0.165271148 | 0.18535056 | 0.15335070 | 0.21550280 | 0.17917597 | 0.16417289 | 0.27567773 | 0.22575832 |\n", "| L4 IT | 0.16471637 | 0.25250309 | 0.06892663 | 0.13671572 | 0.18474821 | 0.17050393 | 0.08920877 | 0.23094039 | 0.24467076 | 0.27871474 | ⋯ | 0.04458168 | 0.00000000 | 0.180937100 | 0.15869556 | 0.13900225 | 0.18290124 | 0.13715859 | 0.13395065 | 0.13677853 | 0.16144940 |\n", "| L5 ET | 0.20706568 | 0.19360176 | 0.14415534 | 0.11856450 | 0.18346170 | 0.13412312 | 0.10113938 | 0.27132123 | 0.09226130 | 0.17075056 | ⋯ | 0.11590089 | 0.13467962 | 0.170940135 | 0.16251591 | 0.05472228 | 0.10597412 | 0.16188119 | 0.21649588 | 0.16743913 | 0.12237632 |\n", "| L5 IT | 0.16242333 | 0.13732842 | 0.18082827 | 0.17326712 | 0.19442305 | 0.20946911 | 0.24591201 | 0.27064330 | 0.13666289 | 0.18165560 | ⋯ | 0.25095868 | 0.16397068 | 0.191098364 | 0.19223919 | 0.05121593 | 0.04955691 | 0.17054180 | 0.15125523 | 0.29045373 | 0.15596546 |\n", "| L5/6 NP | 0.17682510 | 0.17168430 | 0.22210132 | 0.30272253 | 0.23861505 | 0.17540241 | 0.11077489 | 0.17732780 | 0.25505614 | 0.20524138 | ⋯ | 0.12760837 | 0.17204151 | 0.089876848 | 0.16253813 | 0.19312200 | 0.15784061 | 0.17973737 | 0.25055601 | 0.09918409 | 0.16351599 |\n", "| L6 CT | 0.13674189 | 0.12445942 | 0.20063602 | 0.09033107 | 0.07238937 | 0.03989505 | 0.14636778 | 0.18273030 | 0.12128981 | 0.15349504 | ⋯ | 0.20730930 | 0.22864228 | 0.170433136 | 0.29503056 | 0.09647094 | 0.12509675 | 0.19654670 | 0.19717937 | 0.15474205 | 0.12163607 |\n", "| L6 IT | 0.15723506 | 0.21127879 | 0.19373085 | 0.19833235 | 0.26868143 | 0.23147316 | 0.07515243 | 0.22912920 | 0.15145255 | 0.11760925 | ⋯ | 0.11533203 | 0.20281953 | 0.207533670 | 0.11794785 | 0.11203711 | 0.11256509 | 0.06298456 | 0.16141362 | 0.07957494 | 0.17575141 |\n", "| L6 IT Car3 | 0.16696287 | 0.06945630 | 0.27214279 | 0.16986778 | 0.24244700 | 0.11350117 | 0.17154977 | 0.20428368 | 0.17596088 | 0.16768866 | ⋯ | 0.01495314 | 0.15191649 | 0.160299750 | 0.16621598 | 0.15825569 | 0.12141304 | 0.18526203 | 0.23516773 | 0.14165676 | 0.10925536 |\n", "| L6b | 0.16076999 | 0.16652822 | 0.25181404 | 0.15602638 | 0.19402899 | 0.17695179 | 0.17701278 | 0.14307602 | 0.25285512 | 0.22433518 | ⋯ | 0.11182201 | 0.14072208 | 0.077447094 | 0.14082922 | 0.22319200 | 0.17594450 | 0.15719453 | 0.21465162 | 0.17789720 | 0.12589230 |\n", "| Astro | 0.21103566 | 0.23385411 | 0.06529184 | 0.19650894 | 0.17522762 | 0.10398979 | 0.16821627 | 0.17716151 | 0.16913898 | 0.24040225 | ⋯ | 0.17159964 | 0.16919816 | 0.149638641 | 0.18839178 | 0.07173119 | 0.25763022 | 0.19170959 | 0.11401255 | 0.17670488 | 0.22043572 |\n", "| Endo | 0.19715339 | 0.13071821 | 0.18689669 | 0.11735937 | 0.14584475 | 0.16646474 | 0.09593277 | 0.18124034 | 0.26413374 | 0.21145460 | ⋯ | 0.13009118 | 0.08705064 | 0.162365097 | 0.20685108 | 0.22920021 | 0.23850814 | 0.20722626 | 0.21281981 | 0.19684288 | 0.08770064 |\n", "| Micro-PVM | 0.12833390 | 0.22015716 | 0.12793123 | 0.20954085 | 0.11918398 | 0.12920344 | 0.18107993 | 0.24270886 | 0.23399300 | 0.13146060 | ⋯ | 0.18714130 | 0.15763162 | 0.380638423 | 0.20498388 | 0.18048049 | 0.23298913 | 0.16962949 | 0.20939384 | 0.16259308 | 0.19155615 |\n", "| OPC | 0.15919948 | 0.35345536 | 0.16465469 | 0.17394019 | 0.27343947 | 0.17149338 | 0.19049582 | 0.02286925 | 0.22514097 | 0.17971901 | ⋯ | 0.17679311 | 0.21480961 | 0.009632554 | 0.12600315 | 0.22140871 | 0.11581034 | 0.22154267 | 0.16542788 | 0.18567232 | 0.08520339 |\n", "| Oligo | 0.28365681 | 0.11103242 | 0.16378144 | 0.06238968 | 0.12439020 | 0.17855115 | 0.17599517 | 0.30043359 | 0.15198565 | 0.17875897 | ⋯ | 0.20010990 | 0.10015479 | 0.196884219 | 0.24370679 | 0.17086893 | 0.23115176 | 0.15454418 | 0.26449338 | 0.17857450 | 0.19026731 |\n", "| VLMC | 0.23259636 | 0.16106132 | 0.15825326 | 0.18058031 | 0.11391497 | 0.12161584 | 0.21285651 | 0.13384045 | 0.36138895 | 0.12616789 | ⋯ | 0.14599343 | 0.16422426 | 0.050313143 | 0.27343286 | 0.14935278 | 0.16895401 | 0.09438175 | 0.26145124 | 0.05590633 | 0.16802478 |\n", "| Adipocytes | 0.21670994 | 0.18346602 | 0.07606254 | 0.14097467 | 0.15001698 | 0.14603856 | 0.16529356 | 0.20264155 | 0.21967733 | 0.20911556 | ⋯ | 0.17309158 | 0.17349294 | 0.184455776 | 0.23442937 | 0.17445436 | 0.27341056 | 0.33999226 | 0.13445204 | 0.20836369 | 0.15980914 |\n", "| Cardiomyocytes | 0.17335877 | 0.15476226 | 0.09958796 | 0.22887772 | 0.16861021 | 0.21537210 | 0.25713900 | 0.19238028 | 0.24739540 | 0.15602327 | ⋯ | 0.20159602 | 0.12086522 | 0.218425285 | 0.14330581 | 0.27341187 | 0.21335368 | 0.26318658 | 0.10854542 | 0.22779683 | 0.17123438 |\n", "| Endocardial | 0.16024788 | 0.20276349 | 0.05084134 | 0.14585696 | 0.12665514 | 0.28735428 | 0.09600971 | 0.09555507 | 0.21401699 | 0.25139591 | ⋯ | 0.18033671 | 0.07915221 | 0.138290525 | 0.13358488 | 0.23906512 | 0.19784477 | 0.09973270 | 0.24114751 | 0.09234803 | 0.15411904 |\n", "| Endothelial_Arterial | 0.15654861 | 0.16912202 | 0.25763202 | 0.11680439 | 0.22219058 | 0.10260668 | 0.26256310 | 0.17209925 | 0.20160532 | 0.15616768 | ⋯ | 0.15033906 | 0.13518735 | 0.155363385 | 0.18364717 | 0.20275026 | 0.14713616 | 0.21981866 | 0.16841018 | 0.15427325 | 0.10765485 |\n", "| Endothelial_Capillaries | 0.16368928 | 0.16874333 | 0.05259819 | 0.14215234 | 0.14549787 | 0.09339133 | 0.08225645 | 0.20267484 | 0.16564021 | 0.33235269 | ⋯ | 0.18902648 | 0.11338897 | 0.135409155 | 0.25075067 | 0.20377480 | 0.32996212 | 0.18556304 | 0.16028425 | 0.29428953 | 0.28338876 |\n", "| Endothelial_Other | 0.23010475 | 0.11513313 | 0.14970971 | 0.13964463 | 0.14642737 | 0.13059824 | 0.17726562 | 0.35725562 | 0.08690245 | 0.12520101 | ⋯ | 0.17789953 | 0.08993934 | 0.270584239 | 0.28345887 | 0.09814287 | 0.21992383 | 0.21668889 | 0.11464898 | 0.12726341 | 0.22407439 |\n", "| Endothelial_Venous | 0.17860894 | 0.14409890 | 0.20882043 | 0.22001873 | 0.10450804 | 0.23937614 | 0.24732079 | 0.06689223 | 0.19212487 | 0.08924395 | ⋯ | 0.18227000 | 0.29301363 | 0.240961332 | 0.09952925 | 0.28410233 | 0.18355199 | 0.19259557 | 0.18199059 | 0.22356353 | 0.18093872 |\n", "| Epicardium_FB-like | 0.26054145 | 0.10627146 | 0.17071464 | 0.21355322 | 0.24676904 | 0.18605556 | 0.15044694 | 0.17538625 | 0.14275888 | 0.08578576 | ⋯ | 0.15645759 | 0.32636685 | 0.237078341 | 0.08221006 | 0.39212659 | 0.23869877 | 0.22858849 | 0.10447098 | 0.26213058 | 0.10866140 |\n", "| Epicardium_Meso | 0.20055905 | 0.20688971 | 0.08964945 | 0.12836272 | 0.13970729 | 0.35036010 | 0.13660954 | 0.10517106 | 0.13448040 | 0.14714538 | ⋯ | 0.27422681 | 0.22029347 | 0.111860762 | 0.05863555 | 0.19373460 | 0.17340529 | 0.10673359 | 0.22634216 | 0.20649780 | 0.22516512 |\n", "| Epicardium_Proliferating | 0.17705891 | 0.28933458 | 0.19040096 | 0.08437040 | 0.13807528 | 0.27513137 | 0.29796996 | 0.15003033 | 0.03922438 | 0.15073557 | ⋯ | 1.20330758 | 0.28065561 | 0.135300427 | 0.29677117 | 0.12738590 | 0.09407991 | 0.21827836 | 0.05757251 | 0.29001818 | 0.10552753 |\n", "| Fibroblasts | 0.10388116 | 0.19633043 | 0.32141370 | 0.26874698 | 0.19084103 | 0.19914723 | 0.16707002 | 0.14172686 | 0.11903839 | 0.01552671 | ⋯ | 0.28065561 | 1.20330758 | 0.276376557 | 0.15259664 | 0.18251838 | 0.17131339 | 0.22755481 | 0.21802415 | 0.18069949 | 0.22934513 |\n", "| Immature_Cardiomyocytes | 0.14178679 | 0.02398655 | 0.19988495 | 0.24246184 | 0.15769260 | 0.13990113 | 0.19137928 | 0.29190970 | 0.07765599 | 0.16527115 | ⋯ | 0.13530043 | 0.27637656 | 1.203307577 | 0.16657048 | 0.17799832 | 0.23374983 | 0.15572597 | 0.13395277 | 0.22972527 | 0.34749988 |\n", "| Immature_other | 0.17649877 | 0.10245610 | 0.20195581 | 0.12646193 | 0.18233546 | 0.12373987 | 0.21112610 | 0.29076381 | 0.18296069 | 0.18535056 | ⋯ | 0.29677117 | 0.15259664 | 0.166570476 | 1.20330758 | 0.16853945 | 0.16942360 | 0.26411923 | 0.18665941 | 0.19972245 | 0.11365390 |\n", "| Lymphoid_Immune_Cells | 0.18082553 | 0.15050198 | 0.23337046 | 0.16021723 | 0.22590904 | 0.26019920 | 0.15501066 | 0.10195842 | 0.30366849 | 0.15335070 | ⋯ | 0.12738590 | 0.18251838 | 0.177998316 | 0.16853945 | 1.20330758 | 0.26212723 | 0.22812229 | 0.18903499 | 0.21081157 | 0.22853502 |\n", "| Myeloid_Immune_Cells | 0.20842159 | 0.09280053 | 0.12985490 | 0.23728794 | 0.07366606 | 0.14101985 | 0.09965999 | 0.23111344 | 0.16091688 | 0.21550280 | ⋯ | 0.09407991 | 0.17131339 | 0.233749832 | 0.16942360 | 0.26212723 | 1.20330758 | 0.26560175 | 0.19074706 | 0.28236457 | 0.27832889 |\n", "| Neuronal_Cells | 0.17587669 | 0.24086813 | 0.25250128 | 0.14040530 | 0.18589063 | 0.09172387 | 0.16982808 | 0.13692314 | 0.21190333 | 0.17917597 | ⋯ | 0.21827836 | 0.22755481 | 0.155725966 | 0.26411923 | 0.22812229 | 0.26560175 | 1.20330758 | 0.08595871 | 0.23246636 | 0.13490425 |\n", "| Pericytes | 0.13048658 | 0.14959718 | 0.14266107 | 0.26136330 | 0.19715391 | 0.20074149 | 0.07093323 | 0.10546780 | 0.18558687 | 0.16417289 | ⋯ | 0.05757251 | 0.21802415 | 0.133952769 | 0.18665941 | 0.18903499 | 0.19074706 | 0.08595871 | 1.20330758 | 0.12410455 | 0.08175493 |\n", "| Pericytes_Stromal | 0.14199307 | 0.14934393 | 0.17350379 | 0.20663196 | 0.17115453 | 0.08435849 | 0.25057656 | 0.15422150 | 0.12173654 | 0.27567773 | ⋯ | 0.29001818 | 0.18069949 | 0.229725268 | 0.19972245 | 0.21081157 | 0.28236457 | 0.23246636 | 0.12410455 | 1.20330758 | 0.21587325 |\n", "| Smooth_Muscle_Cells | 0.23997149 | 0.15382051 | 0.17849828 | 0.18134501 | 0.19725048 | 0.12349269 | 0.22148024 | 0.30739960 | 0.16263191 | 0.22575832 | ⋯ | 0.10552753 | 0.22934513 | 0.347499885 | 0.11365390 | 0.22853502 | 0.27832889 | 0.13490425 | 0.08175493 | 0.21587325 | 1.20330758 |\n", "\n" ], "text/plain": [ " Chandelier Lamp5 Lamp5_Lhx6 Pax6 Pvalb \n", "Chandelier 1.20330758 0.15968528 0.15291785 0.04511277 0.16325579\n", "Lamp5 0.15968528 1.20330758 0.12925042 0.16790264 0.19095669\n", "Lamp5_Lhx6 0.15291785 0.12925042 1.20330758 0.19073092 0.21196927\n", "Pax6 0.04511277 0.16790264 0.19073092 1.20330758 0.22717899\n", "Pvalb 0.16325579 0.19095669 0.21196927 0.22717899 1.20330758\n", "Sncg 0.24261659 0.20377969 0.14034849 0.24349619 0.23352632\n", "Sst 0.21584432 0.19572606 0.29890308 0.21270595 0.17459137\n", "Sst Chodl 0.19318252 0.08471194 0.19568027 0.22160009 0.14099836\n", "Vip 0.17398419 0.22959104 0.19690524 0.16988884 0.14990011\n", "L2/3 IT 0.16669807 0.21480699 0.14493024 0.19401265 0.22669809\n", "L4 IT 0.16471637 0.25250309 0.06892663 0.13671572 0.18474821\n", "L5 ET 0.20706568 0.19360176 0.14415534 0.11856450 0.18346170\n", "L5 IT 0.16242333 0.13732842 0.18082827 0.17326712 0.19442305\n", "L5/6 NP 0.17682510 0.17168430 0.22210132 0.30272253 0.23861505\n", "L6 CT 0.13674189 0.12445942 0.20063602 0.09033107 0.07238937\n", "L6 IT 0.15723506 0.21127879 0.19373085 0.19833235 0.26868143\n", "L6 IT Car3 0.16696287 0.06945630 0.27214279 0.16986778 0.24244700\n", "L6b 0.16076999 0.16652822 0.25181404 0.15602638 0.19402899\n", "Astro 0.21103566 0.23385411 0.06529184 0.19650894 0.17522762\n", "Endo 0.19715339 0.13071821 0.18689669 0.11735937 0.14584475\n", "Micro-PVM 0.12833390 0.22015716 0.12793123 0.20954085 0.11918398\n", "OPC 0.15919948 0.35345536 0.16465469 0.17394019 0.27343947\n", "Oligo 0.28365681 0.11103242 0.16378144 0.06238968 0.12439020\n", "VLMC 0.23259636 0.16106132 0.15825326 0.18058031 0.11391497\n", "Adipocytes 0.21670994 0.18346602 0.07606254 0.14097467 0.15001698\n", "Cardiomyocytes 0.17335877 0.15476226 0.09958796 0.22887772 0.16861021\n", "Endocardial 0.16024788 0.20276349 0.05084134 0.14585696 0.12665514\n", "Endothelial_Arterial 0.15654861 0.16912202 0.25763202 0.11680439 0.22219058\n", "Endothelial_Capillaries 0.16368928 0.16874333 0.05259819 0.14215234 0.14549787\n", "Endothelial_Other 0.23010475 0.11513313 0.14970971 0.13964463 0.14642737\n", "Endothelial_Venous 0.17860894 0.14409890 0.20882043 0.22001873 0.10450804\n", "Epicardium_FB-like 0.26054145 0.10627146 0.17071464 0.21355322 0.24676904\n", "Epicardium_Meso 0.20055905 0.20688971 0.08964945 0.12836272 0.13970729\n", "Epicardium_Proliferating 0.17705891 0.28933458 0.19040096 0.08437040 0.13807528\n", "Fibroblasts 0.10388116 0.19633043 0.32141370 0.26874698 0.19084103\n", "Immature_Cardiomyocytes 0.14178679 0.02398655 0.19988495 0.24246184 0.15769260\n", "Immature_other 0.17649877 0.10245610 0.20195581 0.12646193 0.18233546\n", "Lymphoid_Immune_Cells 0.18082553 0.15050198 0.23337046 0.16021723 0.22590904\n", "Myeloid_Immune_Cells 0.20842159 0.09280053 0.12985490 0.23728794 0.07366606\n", "Neuronal_Cells 0.17587669 0.24086813 0.25250128 0.14040530 0.18589063\n", "Pericytes 0.13048658 0.14959718 0.14266107 0.26136330 0.19715391\n", "Pericytes_Stromal 0.14199307 0.14934393 0.17350379 0.20663196 0.17115453\n", "Smooth_Muscle_Cells 0.23997149 0.15382051 0.17849828 0.18134501 0.19725048\n", " Sncg Sst Sst.Chodl Vip L2.3.IT \n", "Chandelier 0.24261659 0.21584432 0.19318252 0.17398419 0.16669807\n", "Lamp5 0.20377969 0.19572606 0.08471194 0.22959104 0.21480699\n", "Lamp5_Lhx6 0.14034849 0.29890308 0.19568027 0.19690524 0.14493024\n", "Pax6 0.24349619 0.21270595 0.22160009 0.16988884 0.19401265\n", "Pvalb 0.23352632 0.17459137 0.14099836 0.14990011 0.22669809\n", "Sncg 1.20330758 0.18096049 0.09266834 0.11279816 0.22585441\n", "Sst 0.18096049 1.20330758 0.14954763 0.14457034 0.17400722\n", "Sst Chodl 0.09266834 0.14954763 1.20330758 0.05667861 0.13662974\n", "Vip 0.11279816 0.14457034 0.05667861 1.20330758 0.19538263\n", "L2/3 IT 0.22585441 0.17400722 0.13662974 0.19538263 1.20330758\n", "L4 IT 0.17050393 0.08920877 0.23094039 0.24467076 0.27871474\n", "L5 ET 0.13412312 0.10113938 0.27132123 0.09226130 0.17075056\n", "L5 IT 0.20946911 0.24591201 0.27064330 0.13666289 0.18165560\n", "L5/6 NP 0.17540241 0.11077489 0.17732780 0.25505614 0.20524138\n", "L6 CT 0.03989505 0.14636778 0.18273030 0.12128981 0.15349504\n", "L6 IT 0.23147316 0.07515243 0.22912920 0.15145255 0.11760925\n", "L6 IT Car3 0.11350117 0.17154977 0.20428368 0.17596088 0.16768866\n", "L6b 0.17695179 0.17701278 0.14307602 0.25285512 0.22433518\n", "Astro 0.10398979 0.16821627 0.17716151 0.16913898 0.24040225\n", "Endo 0.16646474 0.09593277 0.18124034 0.26413374 0.21145460\n", "Micro-PVM 0.12920344 0.18107993 0.24270886 0.23399300 0.13146060\n", "OPC 0.17149338 0.19049582 0.02286925 0.22514097 0.17971901\n", "Oligo 0.17855115 0.17599517 0.30043359 0.15198565 0.17875897\n", "VLMC 0.12161584 0.21285651 0.13384045 0.36138895 0.12616789\n", "Adipocytes 0.14603856 0.16529356 0.20264155 0.21967733 0.20911556\n", "Cardiomyocytes 0.21537210 0.25713900 0.19238028 0.24739540 0.15602327\n", "Endocardial 0.28735428 0.09600971 0.09555507 0.21401699 0.25139591\n", "Endothelial_Arterial 0.10260668 0.26256310 0.17209925 0.20160532 0.15616768\n", "Endothelial_Capillaries 0.09339133 0.08225645 0.20267484 0.16564021 0.33235269\n", "Endothelial_Other 0.13059824 0.17726562 0.35725562 0.08690245 0.12520101\n", "Endothelial_Venous 0.23937614 0.24732079 0.06689223 0.19212487 0.08924395\n", "Epicardium_FB-like 0.18605556 0.15044694 0.17538625 0.14275888 0.08578576\n", "Epicardium_Meso 0.35036010 0.13660954 0.10517106 0.13448040 0.14714538\n", "Epicardium_Proliferating 0.27513137 0.29796996 0.15003033 0.03922438 0.15073557\n", "Fibroblasts 0.19914723 0.16707002 0.14172686 0.11903839 0.01552671\n", "Immature_Cardiomyocytes 0.13990113 0.19137928 0.29190970 0.07765599 0.16527115\n", "Immature_other 0.12373987 0.21112610 0.29076381 0.18296069 0.18535056\n", "Lymphoid_Immune_Cells 0.26019920 0.15501066 0.10195842 0.30366849 0.15335070\n", "Myeloid_Immune_Cells 0.14101985 0.09965999 0.23111344 0.16091688 0.21550280\n", "Neuronal_Cells 0.09172387 0.16982808 0.13692314 0.21190333 0.17917597\n", "Pericytes 0.20074149 0.07093323 0.10546780 0.18558687 0.16417289\n", "Pericytes_Stromal 0.08435849 0.25057656 0.15422150 0.12173654 0.27567773\n", "Smooth_Muscle_Cells 0.12349269 0.22148024 0.30739960 0.16263191 0.22575832\n", " ⋯ Epicardium_Proliferating Fibroblasts\n", "Chandelier ⋯ 0.17705891 0.10388116 \n", "Lamp5 ⋯ 0.28933458 0.19633043 \n", "Lamp5_Lhx6 ⋯ 0.19040096 0.32141370 \n", "Pax6 ⋯ 0.08437040 0.26874698 \n", "Pvalb ⋯ 0.13807528 0.19084103 \n", "Sncg ⋯ 0.27513137 0.19914723 \n", "Sst ⋯ 0.29796996 0.16707002 \n", "Sst Chodl ⋯ 0.15003033 0.14172686 \n", "Vip ⋯ 0.03922438 0.11903839 \n", "L2/3 IT ⋯ 0.15073557 0.01552671 \n", "L4 IT ⋯ 0.04458168 0.00000000 \n", "L5 ET ⋯ 0.11590089 0.13467962 \n", "L5 IT ⋯ 0.25095868 0.16397068 \n", "L5/6 NP ⋯ 0.12760837 0.17204151 \n", "L6 CT ⋯ 0.20730930 0.22864228 \n", "L6 IT ⋯ 0.11533203 0.20281953 \n", "L6 IT Car3 ⋯ 0.01495314 0.15191649 \n", "L6b ⋯ 0.11182201 0.14072208 \n", "Astro ⋯ 0.17159964 0.16919816 \n", "Endo ⋯ 0.13009118 0.08705064 \n", "Micro-PVM ⋯ 0.18714130 0.15763162 \n", "OPC ⋯ 0.17679311 0.21480961 \n", "Oligo ⋯ 0.20010990 0.10015479 \n", "VLMC ⋯ 0.14599343 0.16422426 \n", "Adipocytes ⋯ 0.17309158 0.17349294 \n", "Cardiomyocytes ⋯ 0.20159602 0.12086522 \n", "Endocardial ⋯ 0.18033671 0.07915221 \n", "Endothelial_Arterial ⋯ 0.15033906 0.13518735 \n", "Endothelial_Capillaries ⋯ 0.18902648 0.11338897 \n", "Endothelial_Other ⋯ 0.17789953 0.08993934 \n", "Endothelial_Venous ⋯ 0.18227000 0.29301363 \n", "Epicardium_FB-like ⋯ 0.15645759 0.32636685 \n", "Epicardium_Meso ⋯ 0.27422681 0.22029347 \n", "Epicardium_Proliferating ⋯ 1.20330758 0.28065561 \n", "Fibroblasts ⋯ 0.28065561 1.20330758 \n", "Immature_Cardiomyocytes ⋯ 0.13530043 0.27637656 \n", "Immature_other ⋯ 0.29677117 0.15259664 \n", "Lymphoid_Immune_Cells ⋯ 0.12738590 0.18251838 \n", "Myeloid_Immune_Cells ⋯ 0.09407991 0.17131339 \n", "Neuronal_Cells ⋯ 0.21827836 0.22755481 \n", "Pericytes ⋯ 0.05757251 0.21802415 \n", "Pericytes_Stromal ⋯ 0.29001818 0.18069949 \n", "Smooth_Muscle_Cells ⋯ 0.10552753 0.22934513 \n", " Immature_Cardiomyocytes Immature_other\n", "Chandelier 0.141786791 0.17649877 \n", "Lamp5 0.023986548 0.10245610 \n", "Lamp5_Lhx6 0.199884952 0.20195581 \n", "Pax6 0.242461839 0.12646193 \n", "Pvalb 0.157692605 0.18233546 \n", "Sncg 0.139901127 0.12373987 \n", "Sst 0.191379276 0.21112610 \n", "Sst Chodl 0.291909695 0.29076381 \n", "Vip 0.077655989 0.18296069 \n", "L2/3 IT 0.165271148 0.18535056 \n", "L4 IT 0.180937100 0.15869556 \n", "L5 ET 0.170940135 0.16251591 \n", "L5 IT 0.191098364 0.19223919 \n", "L5/6 NP 0.089876848 0.16253813 \n", "L6 CT 0.170433136 0.29503056 \n", "L6 IT 0.207533670 0.11794785 \n", "L6 IT Car3 0.160299750 0.16621598 \n", "L6b 0.077447094 0.14082922 \n", "Astro 0.149638641 0.18839178 \n", "Endo 0.162365097 0.20685108 \n", "Micro-PVM 0.380638423 0.20498388 \n", "OPC 0.009632554 0.12600315 \n", "Oligo 0.196884219 0.24370679 \n", "VLMC 0.050313143 0.27343286 \n", "Adipocytes 0.184455776 0.23442937 \n", "Cardiomyocytes 0.218425285 0.14330581 \n", "Endocardial 0.138290525 0.13358488 \n", "Endothelial_Arterial 0.155363385 0.18364717 \n", "Endothelial_Capillaries 0.135409155 0.25075067 \n", "Endothelial_Other 0.270584239 0.28345887 \n", "Endothelial_Venous 0.240961332 0.09952925 \n", "Epicardium_FB-like 0.237078341 0.08221006 \n", "Epicardium_Meso 0.111860762 0.05863555 \n", "Epicardium_Proliferating 0.135300427 0.29677117 \n", "Fibroblasts 0.276376557 0.15259664 \n", "Immature_Cardiomyocytes 1.203307577 0.16657048 \n", "Immature_other 0.166570476 1.20330758 \n", "Lymphoid_Immune_Cells 0.177998316 0.16853945 \n", "Myeloid_Immune_Cells 0.233749832 0.16942360 \n", "Neuronal_Cells 0.155725966 0.26411923 \n", "Pericytes 0.133952769 0.18665941 \n", "Pericytes_Stromal 0.229725268 0.19972245 \n", "Smooth_Muscle_Cells 0.347499885 0.11365390 \n", " Lymphoid_Immune_Cells Myeloid_Immune_Cells\n", "Chandelier 0.18082553 0.20842159 \n", "Lamp5 0.15050198 0.09280053 \n", "Lamp5_Lhx6 0.23337046 0.12985490 \n", "Pax6 0.16021723 0.23728794 \n", "Pvalb 0.22590904 0.07366606 \n", "Sncg 0.26019920 0.14101985 \n", "Sst 0.15501066 0.09965999 \n", "Sst Chodl 0.10195842 0.23111344 \n", "Vip 0.30366849 0.16091688 \n", "L2/3 IT 0.15335070 0.21550280 \n", "L4 IT 0.13900225 0.18290124 \n", "L5 ET 0.05472228 0.10597412 \n", "L5 IT 0.05121593 0.04955691 \n", "L5/6 NP 0.19312200 0.15784061 \n", "L6 CT 0.09647094 0.12509675 \n", "L6 IT 0.11203711 0.11256509 \n", "L6 IT Car3 0.15825569 0.12141304 \n", "L6b 0.22319200 0.17594450 \n", "Astro 0.07173119 0.25763022 \n", "Endo 0.22920021 0.23850814 \n", "Micro-PVM 0.18048049 0.23298913 \n", "OPC 0.22140871 0.11581034 \n", "Oligo 0.17086893 0.23115176 \n", "VLMC 0.14935278 0.16895401 \n", "Adipocytes 0.17445436 0.27341056 \n", "Cardiomyocytes 0.27341187 0.21335368 \n", "Endocardial 0.23906512 0.19784477 \n", "Endothelial_Arterial 0.20275026 0.14713616 \n", "Endothelial_Capillaries 0.20377480 0.32996212 \n", "Endothelial_Other 0.09814287 0.21992383 \n", "Endothelial_Venous 0.28410233 0.18355199 \n", "Epicardium_FB-like 0.39212659 0.23869877 \n", "Epicardium_Meso 0.19373460 0.17340529 \n", "Epicardium_Proliferating 0.12738590 0.09407991 \n", "Fibroblasts 0.18251838 0.17131339 \n", "Immature_Cardiomyocytes 0.17799832 0.23374983 \n", "Immature_other 0.16853945 0.16942360 \n", "Lymphoid_Immune_Cells 1.20330758 0.26212723 \n", "Myeloid_Immune_Cells 0.26212723 1.20330758 \n", "Neuronal_Cells 0.22812229 0.26560175 \n", "Pericytes 0.18903499 0.19074706 \n", "Pericytes_Stromal 0.21081157 0.28236457 \n", "Smooth_Muscle_Cells 0.22853502 0.27832889 \n", " Neuronal_Cells Pericytes Pericytes_Stromal\n", "Chandelier 0.17587669 0.13048658 0.14199307 \n", "Lamp5 0.24086813 0.14959718 0.14934393 \n", "Lamp5_Lhx6 0.25250128 0.14266107 0.17350379 \n", "Pax6 0.14040530 0.26136330 0.20663196 \n", "Pvalb 0.18589063 0.19715391 0.17115453 \n", "Sncg 0.09172387 0.20074149 0.08435849 \n", "Sst 0.16982808 0.07093323 0.25057656 \n", "Sst Chodl 0.13692314 0.10546780 0.15422150 \n", "Vip 0.21190333 0.18558687 0.12173654 \n", "L2/3 IT 0.17917597 0.16417289 0.27567773 \n", "L4 IT 0.13715859 0.13395065 0.13677853 \n", "L5 ET 0.16188119 0.21649588 0.16743913 \n", "L5 IT 0.17054180 0.15125523 0.29045373 \n", "L5/6 NP 0.17973737 0.25055601 0.09918409 \n", "L6 CT 0.19654670 0.19717937 0.15474205 \n", "L6 IT 0.06298456 0.16141362 0.07957494 \n", "L6 IT Car3 0.18526203 0.23516773 0.14165676 \n", "L6b 0.15719453 0.21465162 0.17789720 \n", "Astro 0.19170959 0.11401255 0.17670488 \n", "Endo 0.20722626 0.21281981 0.19684288 \n", "Micro-PVM 0.16962949 0.20939384 0.16259308 \n", "OPC 0.22154267 0.16542788 0.18567232 \n", "Oligo 0.15454418 0.26449338 0.17857450 \n", "VLMC 0.09438175 0.26145124 0.05590633 \n", "Adipocytes 0.33999226 0.13445204 0.20836369 \n", "Cardiomyocytes 0.26318658 0.10854542 0.22779683 \n", "Endocardial 0.09973270 0.24114751 0.09234803 \n", "Endothelial_Arterial 0.21981866 0.16841018 0.15427325 \n", "Endothelial_Capillaries 0.18556304 0.16028425 0.29428953 \n", "Endothelial_Other 0.21668889 0.11464898 0.12726341 \n", "Endothelial_Venous 0.19259557 0.18199059 0.22356353 \n", "Epicardium_FB-like 0.22858849 0.10447098 0.26213058 \n", "Epicardium_Meso 0.10673359 0.22634216 0.20649780 \n", "Epicardium_Proliferating 0.21827836 0.05757251 0.29001818 \n", "Fibroblasts 0.22755481 0.21802415 0.18069949 \n", "Immature_Cardiomyocytes 0.15572597 0.13395277 0.22972527 \n", "Immature_other 0.26411923 0.18665941 0.19972245 \n", "Lymphoid_Immune_Cells 0.22812229 0.18903499 0.21081157 \n", "Myeloid_Immune_Cells 0.26560175 0.19074706 0.28236457 \n", "Neuronal_Cells 1.20330758 0.08595871 0.23246636 \n", "Pericytes 0.08595871 1.20330758 0.12410455 \n", "Pericytes_Stromal 0.23246636 0.12410455 1.20330758 \n", "Smooth_Muscle_Cells 0.13490425 0.08175493 0.21587325 \n", " Smooth_Muscle_Cells\n", "Chandelier 0.23997149 \n", "Lamp5 0.15382051 \n", "Lamp5_Lhx6 0.17849828 \n", "Pax6 0.18134501 \n", "Pvalb 0.19725048 \n", "Sncg 0.12349269 \n", "Sst 0.22148024 \n", "Sst Chodl 0.30739960 \n", "Vip 0.16263191 \n", "L2/3 IT 0.22575832 \n", "L4 IT 0.16144940 \n", "L5 ET 0.12237632 \n", "L5 IT 0.15596546 \n", "L5/6 NP 0.16351599 \n", "L6 CT 0.12163607 \n", "L6 IT 0.17575141 \n", "L6 IT Car3 0.10925536 \n", "L6b 0.12589230 \n", "Astro 0.22043572 \n", "Endo 0.08770064 \n", "Micro-PVM 0.19155615 \n", "OPC 0.08520339 \n", "Oligo 0.19026731 \n", "VLMC 0.16802478 \n", "Adipocytes 0.15980914 \n", "Cardiomyocytes 0.17123438 \n", "Endocardial 0.15411904 \n", "Endothelial_Arterial 0.10765485 \n", "Endothelial_Capillaries 0.28338876 \n", "Endothelial_Other 0.22407439 \n", "Endothelial_Venous 0.18093872 \n", "Epicardium_FB-like 0.10866140 \n", "Epicardium_Meso 0.22516512 \n", "Epicardium_Proliferating 0.10552753 \n", "Fibroblasts 0.22934513 \n", "Immature_Cardiomyocytes 0.34749988 \n", "Immature_other 0.11365390 \n", "Lymphoid_Immune_Cells 0.22853502 \n", "Myeloid_Immune_Cells 0.27832889 \n", "Neuronal_Cells 0.13490425 \n", "Pericytes 0.08175493 \n", "Pericytes_Stromal 0.21587325 \n", "Smooth_Muscle_Cells 1.20330758 " ] }, "metadata": {}, "output_type": "display_data" } ], "source": [ "net" ] }, { "cell_type": "code", "execution_count": 42, "id": "ec4367d8", "metadata": {}, "outputs": [], "source": [ "aurocs <- neighbor_voting(genes.labels, net, output = 'AUROC') \n", "\n", "avgprcs <- neighbor_voting(genes.labels, net, output = 'PR') " ] }, { "cell_type": "code", "execution_count": 43, "id": "a472341e", "metadata": {}, "outputs": [ { "data": { "text/html": [ "\n", "\n", "\n", "\t\n", "\n", "\n", "\t\n", "\t\n", "\t\n", "\t\n", "\n", "
A matrix: 4 × 3 of type dbl
aucavg_node_degreedegree_null_auc
CGE.derived0.41880348.6320250.6282051
MGE.derived0.57017548.4684050.3578947
Glut0.87254908.4936000.3986928
Gaba0.50653598.5411250.4771242
\n" ], "text/latex": [ "A matrix: 4 × 3 of type dbl\n", "\\begin{tabular}{r|lll}\n", " & auc & avg\\_node\\_degree & degree\\_null\\_auc\\\\\n", "\\hline\n", "\tCGE.derived & 0.4188034 & 8.632025 & 0.6282051\\\\\n", "\tMGE.derived & 0.5701754 & 8.468405 & 0.3578947\\\\\n", "\tGlut & 0.8725490 & 8.493600 & 0.3986928\\\\\n", "\tGaba & 0.5065359 & 8.541125 & 0.4771242\\\\\n", "\\end{tabular}\n" ], "text/markdown": [ "\n", "A matrix: 4 × 3 of type dbl\n", "\n", "| | auc | avg_node_degree | degree_null_auc |\n", "|---|---|---|---|\n", "| CGE.derived | 0.4188034 | 8.632025 | 0.6282051 |\n", "| MGE.derived | 0.5701754 | 8.468405 | 0.3578947 |\n", "| Glut | 0.8725490 | 8.493600 | 0.3986928 |\n", "| Gaba | 0.5065359 | 8.541125 | 0.4771242 |\n", "\n" ], "text/plain": [ " auc avg_node_degree degree_null_auc\n", "CGE.derived 0.4188034 8.632025 0.6282051 \n", "MGE.derived 0.5701754 8.468405 0.3578947 \n", "Glut 0.8725490 8.493600 0.3986928 \n", "Gaba 0.5065359 8.541125 0.4771242 " ] }, "metadata": {}, "output_type": "display_data" } ], "source": [ "aurocs" ] }, { "cell_type": "code", "execution_count": 19, "id": "c7c11920", "metadata": {}, "outputs": [ { "data": { "text/html": [ "\n", "\n", "\n", "\t\n", "\n", "\n", "\t\n", "\t\n", "\t\n", "\n", "
A matrix: 3 × 3 of type dbl
aucavg_node_degreedegree_null_auc
brain0.84210538.5588200.4868421
heart0.82175938.6080510.5131579
Gaba0.60130728.5411250.4771242
\n" ], "text/latex": [ "A matrix: 3 × 3 of type dbl\n", "\\begin{tabular}{r|lll}\n", " & auc & avg\\_node\\_degree & degree\\_null\\_auc\\\\\n", "\\hline\n", "\tbrain & 0.8421053 & 8.558820 & 0.4868421\\\\\n", "\theart & 0.8217593 & 8.608051 & 0.5131579\\\\\n", "\tGaba & 0.6013072 & 8.541125 & 0.4771242\\\\\n", "\\end{tabular}\n" ], "text/markdown": [ "\n", "A matrix: 3 × 3 of type dbl\n", "\n", "| | auc | avg_node_degree | degree_null_auc |\n", "|---|---|---|---|\n", "| brain | 0.8421053 | 8.558820 | 0.4868421 |\n", "| heart | 0.8217593 | 8.608051 | 0.5131579 |\n", "| Gaba | 0.6013072 | 8.541125 | 0.4771242 |\n", "\n" ], "text/plain": [ " auc avg_node_degree degree_null_auc\n", "brain 0.8421053 8.558820 0.4868421 \n", "heart 0.8217593 8.608051 0.5131579 \n", "Gaba 0.6013072 8.541125 0.4771242 " ] }, "metadata": {}, "output_type": "display_data" } ], "source": [ "aurocs" ] }, { "cell_type": "code", "execution_count": 33, "id": "6e10757e", "metadata": {}, "outputs": [ { "data": { "text/html": [ "\n", "\n", "\n", "\t\n", "\n", "\n", "\t\n", "\t\n", "\t\n", "\t\n", "\n", "
A matrix: 4 × 3 of type dbl
aucavg_node_degreedegree_null_auc
brain0.80921058.5588200.4868421
heart0.82638898.6080510.5131579
Gaba0.61764718.5411250.4771242
Glut0.90196088.4936000.3986928
\n" ], "text/latex": [ "A matrix: 4 × 3 of type dbl\n", "\\begin{tabular}{r|lll}\n", " & auc & avg\\_node\\_degree & degree\\_null\\_auc\\\\\n", "\\hline\n", "\tbrain & 0.8092105 & 8.558820 & 0.4868421\\\\\n", "\theart & 0.8263889 & 8.608051 & 0.5131579\\\\\n", "\tGaba & 0.6176471 & 8.541125 & 0.4771242\\\\\n", "\tGlut & 0.9019608 & 8.493600 & 0.3986928\\\\\n", "\\end{tabular}\n" ], "text/markdown": [ "\n", "A matrix: 4 × 3 of type dbl\n", "\n", "| | auc | avg_node_degree | degree_null_auc |\n", "|---|---|---|---|\n", "| brain | 0.8092105 | 8.558820 | 0.4868421 |\n", "| heart | 0.8263889 | 8.608051 | 0.5131579 |\n", "| Gaba | 0.6176471 | 8.541125 | 0.4771242 |\n", "| Glut | 0.9019608 | 8.493600 | 0.3986928 |\n", "\n" ], "text/plain": [ " auc avg_node_degree degree_null_auc\n", "brain 0.8092105 8.558820 0.4868421 \n", "heart 0.8263889 8.608051 0.5131579 \n", "Gaba 0.6176471 8.541125 0.4771242 \n", "Glut 0.9019608 8.493600 0.3986928 " ] }, "metadata": {}, "output_type": "display_data" } ], "source": [ "aurocs" ] }, { "cell_type": "code", "execution_count": null, "id": "84017e91", "metadata": {}, "outputs": [], "source": [] } ], "metadata": { "kernelspec": { "display_name": "R4.2.0", "language": "R", "name": "ir34" }, "language_info": { "codemirror_mode": "r", "file_extension": ".r", "mimetype": "text/x-r-source", "name": "R", "pygments_lexer": "r", "version": "4.2.0" } }, "nbformat": 4, "nbformat_minor": 5 }